Home
last modified time | relevance | path

Searched refs:qcoeff (Results 1 – 25 of 65) sorted by relevance

123

/external/libvpx/libvpx/vpx_dsp/arm/
Dquantize_neon.c18 static INLINE void calculate_dqcoeff_and_store(const int16x8_t qcoeff, in calculate_dqcoeff_and_store() argument
22 vmull_s16(vget_low_s16(qcoeff), vget_low_s16(dequant)); in calculate_dqcoeff_and_store()
24 vmull_s16(vget_high_s16(qcoeff), vget_high_s16(dequant)); in calculate_dqcoeff_and_store()
70 int16x8_t qcoeff = vshrq_n_s16(vqdmulhq_s16(rounded, quant), 1); in vpx_quantize_b_neon() local
72 qcoeff = vaddq_s16(qcoeff, rounded); in vpx_quantize_b_neon()
75 qcoeff = vshrq_n_s16(vqdmulhq_s16(qcoeff, quant_shift), 1); in vpx_quantize_b_neon()
78 qcoeff = veorq_s16(qcoeff, coeff_sign); in vpx_quantize_b_neon()
79 qcoeff = vsubq_s16(qcoeff, coeff_sign); in vpx_quantize_b_neon()
81 qcoeff = vandq_s16(qcoeff, zbin_mask); in vpx_quantize_b_neon()
84 eob_max = vandq_u16(vtstq_s16(qcoeff, neg_one), v_iscan); in vpx_quantize_b_neon()
[all …]
/external/libaom/libaom/av1/encoder/x86/
Dav1_highbd_quantize_sse4.c24 __m128i *qcoeff, __m128i *dquan, in quantize_coeff_phase1() argument
33 qcoeff[0] = _mm_add_epi32(*coeff, param[0]); in quantize_coeff_phase1()
34 qcoeff[1] = _mm_unpackhi_epi32(qcoeff[0], zero); in quantize_coeff_phase1()
35 qcoeff[0] = _mm_unpacklo_epi32(qcoeff[0], zero); in quantize_coeff_phase1()
37 qcoeff[0] = _mm_mul_epi32(qcoeff[0], param[1]); in quantize_coeff_phase1()
38 qcoeff[0] = _mm_srli_epi64(qcoeff[0], shift); in quantize_coeff_phase1()
39 dquan[0] = _mm_mul_epi32(qcoeff[0], param[2]); in quantize_coeff_phase1()
42 qcoeff[2] = _mm_cmplt_epi32(abs_s, param[3]); in quantize_coeff_phase1()
46 static INLINE void quantize_coeff_phase2(__m128i *qcoeff, __m128i *dquan, in quantize_coeff_phase2() argument
54 qcoeff[1] = _mm_mul_epi32(qcoeff[1], param[1]); in quantize_coeff_phase2()
[all …]
Dav1_quantize_avx2.c30 static INLINE void write_zero(tran_low_t *qcoeff) { in write_zero() argument
33 _mm256_storeu_si256((__m256i *)qcoeff, zero); in write_zero()
34 _mm256_storeu_si256((__m256i *)qcoeff + 1, zero); in write_zero()
36 _mm256_storeu_si256((__m256i *)qcoeff, zero); in write_zero()
108 const int16_t *iscan_ptr, tran_low_t *qcoeff, in quantize() argument
121 store_two_quan(q, qcoeff, dq, dqcoeff); in quantize()
130 write_zero(qcoeff); in quantize()
180 tran_low_t *qcoeff, tran_low_t *dqcoeff, in quantize_32x32() argument
197 store_two_quan(q, qcoeff, dq, dqcoeff); in quantize_32x32()
206 write_zero(qcoeff); in quantize_32x32()
[all …]
Dav1_quantize_sse2.c36 tran_low_t *qcoeff, intptr_t offset) { in write_qcoeff() argument
37 tran_low_t *addr = qcoeff + offset; in write_qcoeff()
57 static INLINE void write_zero(tran_low_t *qcoeff, intptr_t offset) { in write_zero() argument
59 tran_low_t *addr = qcoeff + offset; in write_zero()
/external/libvpx/libvpx/vp9/encoder/arm/neon/
Dvp9_quantize_neon.c149 int16x8_t qcoeff = vaddq_s16(coeff_abs, round); in vp9_quantize_fp_32x32_neon() local
159 qcoeff = vqdmulhq_s16(qcoeff, quant); in vp9_quantize_fp_32x32_neon()
162 qcoeff = veorq_s16(qcoeff, coeff_sign); in vp9_quantize_fp_32x32_neon()
163 qcoeff = vsubq_s16(qcoeff, coeff_sign); in vp9_quantize_fp_32x32_neon()
164 qcoeff = vandq_s16(qcoeff, dequant_mask); in vp9_quantize_fp_32x32_neon()
167 dqcoeff_0 = vmull_s16(vget_low_s16(qcoeff), dequant); in vp9_quantize_fp_32x32_neon()
168 dqcoeff_1 = vmull_n_s16(vget_high_s16(qcoeff), dequant_ptr[1]); in vp9_quantize_fp_32x32_neon()
176 eob_max = vandq_u16(vtstq_s16(qcoeff, neg_one), v_iscan); in vp9_quantize_fp_32x32_neon()
178 store_s16q_to_tran_low(qcoeff_ptr, qcoeff); in vp9_quantize_fp_32x32_neon()
203 int16x8_t qcoeff = vaddq_s16(coeff_abs, round); in vp9_quantize_fp_32x32_neon() local
[all …]
/external/libaom/libaom/aom_dsp/x86/
Dquantize_x86.h42 __m128i tmp, qcoeff; in calculate_qcoeff() local
43 qcoeff = _mm_adds_epi16(*coeff, round); in calculate_qcoeff()
44 tmp = _mm_mulhi_epi16(qcoeff, quant); in calculate_qcoeff()
45 qcoeff = _mm_add_epi16(tmp, qcoeff); in calculate_qcoeff()
46 *coeff = _mm_mulhi_epi16(qcoeff, shift); in calculate_qcoeff()
54 __m128i tmp, tmp1, qcoeff; in calculate_qcoeff_log_scale() local
55 qcoeff = _mm_adds_epi16(*coeff, round); in calculate_qcoeff_log_scale()
56 tmp = _mm_mulhi_epi16(qcoeff, quant); in calculate_qcoeff_log_scale()
57 qcoeff = _mm_add_epi16(tmp, qcoeff); in calculate_qcoeff_log_scale()
58 tmp = _mm_mullo_epi16(qcoeff, *shift); in calculate_qcoeff_log_scale()
[all …]
Dquantize_ssse3.c25 __m128i tmp, qcoeff, tmp1; in calculate_qcoeff_64x64() local
26 qcoeff = _mm_adds_epi16(*coeff, round); in calculate_qcoeff_64x64()
27 tmp = _mm_mulhi_epi16(qcoeff, quant); in calculate_qcoeff_64x64()
28 qcoeff = _mm_add_epi16(tmp, qcoeff); in calculate_qcoeff_64x64()
29 tmp = _mm_mullo_epi16(qcoeff, *shift); in calculate_qcoeff_64x64()
31 tmp1 = _mm_mulhi_epi16(qcoeff, *shift); in calculate_qcoeff_64x64()
36 static INLINE void calculate_dqcoeff_and_store_64x64(const __m128i qcoeff, in calculate_dqcoeff_and_store_64x64() argument
41 const __m128i coeff = _mm_abs_epi16(qcoeff); in calculate_dqcoeff_and_store_64x64()
43 const __m128i sign_0 = _mm_unpacklo_epi16(zero, qcoeff); in calculate_dqcoeff_and_store_64x64()
44 const __m128i sign_1 = _mm_unpackhi_epi16(zero, qcoeff); in calculate_dqcoeff_and_store_64x64()
Dhighbd_quantize_intrin_avx2.c67 const int16_t *iscan_ptr, tran_low_t *qcoeff, in quantize() argument
89 _mm256_storeu_si256((__m256i *)qcoeff, q); in quantize()
107 _mm256_storeu_si256((__m256i *)qcoeff, zero); in quantize()
/external/libvpx/libvpx/vpx_dsp/ppc/
Dquantize_vsx.c43 int16x8_t qcoeff = vec_mulhi(rounded, quant); in quantize_coeff() local
44 qcoeff = vec_add(qcoeff, rounded); in quantize_coeff()
45 qcoeff = vec_mulhi(qcoeff, quant_shift); in quantize_coeff()
46 qcoeff = vec_sign(qcoeff, coeff); in quantize_coeff()
47 return vec_and(qcoeff, mask); in quantize_coeff()
56 int16x8_t qcoeff = vec_mulhi(rounded, quant); in quantize_coeff_32() local
57 qcoeff = vec_add(qcoeff, rounded); in quantize_coeff_32()
61 qcoeff = vec_madds(qcoeff, quant_shift, vec_zeros_s16); in quantize_coeff_32()
62 qcoeff = vec_sign(qcoeff, coeff); in quantize_coeff_32()
63 return vec_and(qcoeff, mask); in quantize_coeff_32()
[all …]
/external/libvpx/libvpx/vpx_dsp/x86/
Dquantize_sse2.h40 __m128i tmp, qcoeff; in calculate_qcoeff() local
41 qcoeff = _mm_adds_epi16(*coeff, round); in calculate_qcoeff()
42 tmp = _mm_mulhi_epi16(qcoeff, quant); in calculate_qcoeff()
43 qcoeff = _mm_add_epi16(tmp, qcoeff); in calculate_qcoeff()
44 *coeff = _mm_mulhi_epi16(qcoeff, shift); in calculate_qcoeff()
47 static INLINE void calculate_dqcoeff_and_store(__m128i qcoeff, __m128i dequant, in calculate_dqcoeff_and_store() argument
50 const __m128i low = _mm_mullo_epi16(qcoeff, dequant); in calculate_dqcoeff_and_store()
51 const __m128i high = _mm_mulhi_epi16(qcoeff, dequant); in calculate_dqcoeff_and_store()
59 const __m128i dqcoeff16 = _mm_mullo_epi16(qcoeff, dequant); in calculate_dqcoeff_and_store()
Dquantize_ssse3.h20 static INLINE void calculate_dqcoeff_and_store_32x32(const __m128i qcoeff, in calculate_dqcoeff_and_store_32x32() argument
25 const __m128i coeff = _mm_abs_epi16(qcoeff); in calculate_dqcoeff_and_store_32x32()
27 const __m128i sign_0 = _mm_unpacklo_epi16(zero, qcoeff); in calculate_dqcoeff_and_store_32x32()
28 const __m128i sign_1 = _mm_unpackhi_epi16(zero, qcoeff); in calculate_dqcoeff_and_store_32x32()
/external/libvpx/libvpx/vp9/encoder/
Dvp9_encodemb.c69 tran_low_t *const qcoeff = BLOCK_OFFSET(p->qcoeff, block); in vp9_optimize_b() local
117 token_cache[rc] = vp9_pt_energy_class[vp9_get_token(qcoeff[rc])]; in vp9_optimize_b()
131 const int x = qcoeff[rc]; in vp9_optimize_b()
209 (i + 1 != eob) ? vp9_get_token(qcoeff[scan[i + 1]]) : EOB_TOKEN; in vp9_optimize_b()
260 qcoeff[rc] = x1; in vp9_optimize_b()
272 if (sharpness > 0 && abs(qcoeff[rc]) > 1) count_high_values_after_eob++; in vp9_optimize_b()
274 x_prev = qcoeff[rc]; // Update based on selected quantized value. in vp9_optimize_b()
299 const int x = qcoeff[rc]; in vp9_optimize_b()
312 qcoeff[rc] = before_best_eob_qc; in vp9_optimize_b()
317 qcoeff[rc] = 0; in vp9_optimize_b()
[all …]
Dvp9_context_tree.c33 CHECK_MEM_ERROR(cm, ctx->qcoeff[i][k], in alloc_mode_context()
34 vpx_memalign(32, num_pix * sizeof(*ctx->qcoeff[i][k]))); in alloc_mode_context()
40 ctx->qcoeff_pbuf[i][k] = ctx->qcoeff[i][k]; in alloc_mode_context()
55 vpx_free(ctx->qcoeff[i][k]); in free_mode_context()
56 ctx->qcoeff[i][k] = 0; in free_mode_context()
Dvp9_quantize.c167 tran_low_t *qcoeff = BLOCK_OFFSET(p->qcoeff, block), in vp9_regular_quantize_b_4x4() local
172 memset(qcoeff, 0, n_coeffs * sizeof(*qcoeff)); in vp9_regular_quantize_b_4x4()
181 p->quant_shift, qcoeff, dqcoeff, pd->dequant, in vp9_regular_quantize_b_4x4()
187 p->zbin, p->round, p->quant, p->quant_shift, qcoeff, dqcoeff, in vp9_regular_quantize_b_4x4()
/external/libaom/libaom/av1/encoder/
Dencodetxb.c376 const tran_low_t qc = txb_info->qcoeff[coeff_idx];
440 const tran_low_t qc = txb_info->qcoeff[coeff_idx];
461 txb_info->qcoeff[coeff_idx] = qc;
743 const tran_low_t *const qcoeff = BLOCK_OFFSET(p->qcoeff, block); local
758 av1_txb_init_levels(qcoeff, width, height, levels);
771 const tran_low_t v = qcoeff[pos];
797 const tran_low_t v = qcoeff[pos];
812 const tran_low_t v = qcoeff[pos];
902 tran_low_t qc = txb_info->qcoeff[coeff_idx];
969 tran_low_t qc = txb_info->qcoeff[coeff_idx];
[all …]
Dencodetxb.h28 tran_low_t *qcoeff; member
60 int av1_get_txb_entropy_context(const tran_low_t *qcoeff,
/external/libvpx/libvpx/vp8/common/
Dinvtrans.h42 vp8_short_inv_walsh4x4(&xd->block[24].dqcoeff[0], xd->qcoeff); in vp8_inverse_transform_mby()
44 vp8_short_inv_walsh4x4_1(&xd->block[24].dqcoeff[0], xd->qcoeff); in vp8_inverse_transform_mby()
46 eob_adjust(xd->eobs, xd->qcoeff); in vp8_inverse_transform_mby()
50 vp8_dequant_idct_add_y_block(xd->qcoeff, DQC, xd->dst.y_buffer, in vp8_inverse_transform_mby()
Dmbpitch.c37 x->block[r].qcoeff = x->qcoeff + r * 16; in vp8_setup_block_dptrs()
/external/libvpx/libvpx/vp8/decoder/
Ddecodeframe.c134 memset(xd->qcoeff, 0, sizeof(xd->qcoeff)); in decode_macroblock()
180 vp8_dequant_idct_add(b->qcoeff, DQC, dst, dst_stride); in decode_macroblock()
182 vp8_dc_only_idct_add(b->qcoeff[0] * DQC[0], dst, dst_stride, dst, in decode_macroblock()
184 memset(b->qcoeff, 0, 2 * sizeof(b->qcoeff[0])); in decode_macroblock()
211 vp8_short_inv_walsh4x4(&b->dqcoeff[0], xd->qcoeff); in decode_macroblock()
212 memset(b->qcoeff, 0, 16 * sizeof(b->qcoeff[0])); in decode_macroblock()
214 b->dqcoeff[0] = b->qcoeff[0] * xd->dequant_y2[0]; in decode_macroblock()
215 vp8_short_inv_walsh4x4_1(&b->dqcoeff[0], xd->qcoeff); in decode_macroblock()
216 memset(b->qcoeff, 0, 2 * sizeof(b->qcoeff[0])); in decode_macroblock()
225 vp8_dequant_idct_add_y_block(xd->qcoeff, DQC, xd->dst.y_buffer, in decode_macroblock()
[all …]
Dthreading.c126 memset(xd->qcoeff, 0, sizeof(xd->qcoeff)); in mt_decode_macroblock()
194 vp8_dequant_idct_add(b->qcoeff, DQC, dst, dst_stride); in mt_decode_macroblock()
196 vp8_dc_only_idct_add(b->qcoeff[0] * DQC[0], dst, dst_stride, dst, in mt_decode_macroblock()
198 memset(b->qcoeff, 0, 2 * sizeof(b->qcoeff[0])); in mt_decode_macroblock()
225 vp8_short_inv_walsh4x4(&b->dqcoeff[0], xd->qcoeff); in mt_decode_macroblock()
226 memset(b->qcoeff, 0, 16 * sizeof(b->qcoeff[0])); in mt_decode_macroblock()
228 b->dqcoeff[0] = b->qcoeff[0] * xd->dequant_y2[0]; in mt_decode_macroblock()
229 vp8_short_inv_walsh4x4_1(&b->dqcoeff[0], xd->qcoeff); in mt_decode_macroblock()
230 memset(b->qcoeff, 0, 2 * sizeof(b->qcoeff[0])); in mt_decode_macroblock()
239 vp8_dequant_idct_add_y_block(xd->qcoeff, DQC, xd->dst.y_buffer, in mt_decode_macroblock()
[all …]
/external/libvpx/libvpx/vp8/common/x86/
Didctllm_sse2.asm16 ; short *qcoeff - 0
33 mov rax, arg(0) ; qcoeff
101 ; short *qcoeff - 0
118 ; dc is set as first coeff, so no need to load qcoeff
119 mov rax, arg(0) ; qcoeff
141 ; dequantize qcoeff buffer
357 ; short *qcoeff - 0
373 ; dc is set as first coeff, so no need to load qcoeff
374 mov rax, arg(0) ; qcoeff
433 ; short *qcoeff - 0
[all …]
/external/libaom/libaom/test/
Dquantize_func_test.cc114 tran_low_t *qcoeff = dqcoeff_ref + n_coeffs; in QuantizeRun() local
115 tran_low_t *dqcoeff = qcoeff + n_coeffs; in QuantizeRun()
147 quant_shift, qcoeff, dqcoeff, dequant, in QuantizeRun()
151 ASSERT_EQ(qcoeff_ref[j], qcoeff[j]) in QuantizeRun()
281 tran_low_t *qcoeff = dqcoeff_ref + n_coeffs; in TEST_P() local
282 tran_low_t *dqcoeff = qcoeff + n_coeffs; in TEST_P()
305 qcoeff, dqcoeff, dequant, eob, sc->scan, sc->iscan); in TEST_P()
311 quant_(coeff_ptr, n_coeffs, zbin, round_fp, quant_fp, quant_shift, qcoeff, in TEST_P()
/external/libvpx/libvpx/vp8/encoder/x86/
Dvp8_quantize_sse2.c36 short *qcoeff_ptr = d->qcoeff; in vp8_regular_quantize_b_sse2()
129 y0 = _mm_load_si128((__m128i *)(d->qcoeff)); in vp8_regular_quantize_b_sse2()
130 y1 = _mm_load_si128((__m128i *)(d->qcoeff + 8)); in vp8_regular_quantize_b_sse2()
183 _mm_store_si128((__m128i *)(d->qcoeff), x0); in vp8_fast_quantize_b_sse2()
184 _mm_store_si128((__m128i *)(d->qcoeff + 8), x1); in vp8_fast_quantize_b_sse2()
/external/libvpx/libvpx/vp8/common/mips/mmi/
Ddequantize_mmi.c54 : [dqcoeff] "r"(d->dqcoeff), [qcoeff] "r"(d->qcoeff), [DQC] "r"(DQC) in vp8_dequantize_b_mmi()
/external/libvpx/libvpx/test/
Dquantize_test.cc99 EXPECT_EQ(0, memcmp(vp8_comp_->mb.e_mbd.qcoeff, macroblockd_dst_->qcoeff, in CheckOutput()
100 sizeof(*macroblockd_dst_->qcoeff) * kNumBlocks * in CheckOutput()

123