#include <stdlib.h>
#include <string.h>
#include <tmmintrin.h>
#include "config/aom_config.h"
#include "config/aom_dsp_rtcd.h"
#include "aom/aom_integer.h"
#include "aom_dsp/aom_filter.h"
#include "aom_dsp/blend.h"
#include "aom_dsp/x86/masked_variance_intrin_ssse3.h"
#include "aom_dsp/x86/synonyms.h"
#include "aom_ports/mem.h"
static void bilinear_filter(const uint8_t *src, int src_stride, int xoffset,
int yoffset, uint8_t *dst, int w, int h);
static void bilinear_filter8xh(const uint8_t *src, int src_stride, int xoffset,
int yoffset, uint8_t *dst, int h);
static void bilinear_filter4xh(const uint8_t *src, int src_stride, int xoffset,
int yoffset, uint8_t *dst, int h);
static void masked_variance(const uint8_t *src_ptr, int src_stride,
const uint8_t *a_ptr, int a_stride,
const uint8_t *b_ptr, int b_stride,
const uint8_t *m_ptr, int m_stride, int width,
int height, unsigned int *sse, int *sum_);
static void masked_variance8xh(const uint8_t *src_ptr, int src_stride,
const uint8_t *a_ptr, const uint8_t *b_ptr,
const uint8_t *m_ptr, int m_stride, int height,
unsigned int *sse, int *sum_);
static void masked_variance4xh(const uint8_t *src_ptr, int src_stride,
const uint8_t *a_ptr, const uint8_t *b_ptr,
const uint8_t *m_ptr, int m_stride, int height,
unsigned int *sse, int *sum_);
#define MASK_SUBPIX_VAR_SSSE3(W, H) …
#define MASK_SUBPIX_VAR8XH_SSSE3(H) …
#define MASK_SUBPIX_VAR4XH_SSSE3(H) …
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR_SSSE3(…)
MASK_SUBPIX_VAR8XH_SSSE3(…) …
MASK_SUBPIX_VAR8XH_SSSE3(…) …
MASK_SUBPIX_VAR8XH_SSSE3(…) …
MASK_SUBPIX_VAR4XH_SSSE3(…) …
MASK_SUBPIX_VAR4XH_SSSE3(…) …
#if !CONFIG_REALTIME_ONLY
MASK_SUBPIX_VAR4XH_SSSE3(16)
MASK_SUBPIX_VAR_SSSE3(16, 4)
MASK_SUBPIX_VAR8XH_SSSE3(32)
MASK_SUBPIX_VAR_SSSE3(32, 8)
MASK_SUBPIX_VAR_SSSE3(64, 16)
MASK_SUBPIX_VAR_SSSE3(16, 64)
#endif
static inline __m128i filter_block(const __m128i a, const __m128i b,
const __m128i filter) { … }
static void bilinear_filter(const uint8_t *src, int src_stride, int xoffset,
int yoffset, uint8_t *dst, int w, int h) { … }
static inline __m128i filter_block_2rows(const __m128i *a0, const __m128i *b0,
const __m128i *a1, const __m128i *b1,
const __m128i *filter) { … }
static void bilinear_filter8xh(const uint8_t *src, int src_stride, int xoffset,
int yoffset, uint8_t *dst, int h) { … }
static void bilinear_filter4xh(const uint8_t *src, int src_stride, int xoffset,
int yoffset, uint8_t *dst, int h) { … }
static inline void accumulate_block(const __m128i *src, const __m128i *a,
const __m128i *b, const __m128i *m,
__m128i *sum, __m128i *sum_sq) { … }
static void masked_variance(const uint8_t *src_ptr, int src_stride,
const uint8_t *a_ptr, int a_stride,
const uint8_t *b_ptr, int b_stride,
const uint8_t *m_ptr, int m_stride, int width,
int height, unsigned int *sse, int *sum_) { … }
static void masked_variance8xh(const uint8_t *src_ptr, int src_stride,
const uint8_t *a_ptr, const uint8_t *b_ptr,
const uint8_t *m_ptr, int m_stride, int height,
unsigned int *sse, int *sum_) { … }
static void masked_variance4xh(const uint8_t *src_ptr, int src_stride,
const uint8_t *a_ptr, const uint8_t *b_ptr,
const uint8_t *m_ptr, int m_stride, int height,
unsigned int *sse, int *sum_) { … }
#if CONFIG_AV1_HIGHBITDEPTH
static void highbd_bilinear_filter(const uint16_t *src, int src_stride,
int xoffset, int yoffset, uint16_t *dst,
int w, int h);
static void highbd_bilinear_filter4xh(const uint16_t *src, int src_stride,
int xoffset, int yoffset, uint16_t *dst,
int h);
static void highbd_masked_variance(const uint16_t *src_ptr, int src_stride,
const uint16_t *a_ptr, int a_stride,
const uint16_t *b_ptr, int b_stride,
const uint8_t *m_ptr, int m_stride,
int width, int height, uint64_t *sse,
int *sum_);
static void highbd_masked_variance4xh(const uint16_t *src_ptr, int src_stride,
const uint16_t *a_ptr,
const uint16_t *b_ptr,
const uint8_t *m_ptr, int m_stride,
int height, int *sse, int *sum_);
#define HIGHBD_MASK_SUBPIX_VAR_SSSE3 …
#define HIGHBD_MASK_SUBPIX_VAR4XH_SSSE3 …
HIGHBD_MASK_SUBPIX_VAR_SSSE3(128, 128)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(128, 64)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(64, 128)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(64, 64)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(64, 32)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(32, 64)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(32, 32)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(32, 16)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(16, 32)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(16, 16)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(16, 8)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(8, 16)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(8, 8)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(8, 4)
HIGHBD_MASK_SUBPIX_VAR4XH_SSSE3(8)
HIGHBD_MASK_SUBPIX_VAR4XH_SSSE3(4)
#if !CONFIG_REALTIME_ONLY
HIGHBD_MASK_SUBPIX_VAR4XH_SSSE3(16)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(16, 4)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(8, 32)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(32, 8)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(16, 64)
HIGHBD_MASK_SUBPIX_VAR_SSSE3(64, 16)
#endif
static inline __m128i highbd_filter_block(const __m128i a, const __m128i b,
const __m128i filter) {
__m128i v0 = _mm_unpacklo_epi16(a, b);
v0 = _mm_madd_epi16(v0, filter);
v0 = xx_roundn_epu32(v0, FILTER_BITS);
__m128i v1 = _mm_unpackhi_epi16(a, b);
v1 = _mm_madd_epi16(v1, filter);
v1 = xx_roundn_epu32(v1, FILTER_BITS);
return _mm_packs_epi32(v0, v1);
}
static void highbd_bilinear_filter(const uint16_t *src, int src_stride,
int xoffset, int yoffset, uint16_t *dst,
int w, int h) {
int i, j;
if (xoffset == 0) {
uint16_t *b = dst;
for (i = 0; i < h + 1; ++i) {
for (j = 0; j < w; j += 8) {
__m128i x = _mm_loadu_si128((__m128i *)&src[j]);
_mm_storeu_si128((__m128i *)&b[j], x);
}
src += src_stride;
b += w;
}
} else if (xoffset == 4) {
uint16_t *b = dst;
for (i = 0; i < h + 1; ++i) {
for (j = 0; j < w; j += 8) {
__m128i x = _mm_loadu_si128((__m128i *)&src[j]);
__m128i y = _mm_loadu_si128((__m128i *)&src[j + 8]);
__m128i z = _mm_alignr_epi8(y, x, 2);
_mm_storeu_si128((__m128i *)&b[j], _mm_avg_epu16(x, z));
}
src += src_stride;
b += w;
}
} else {
uint16_t *b = dst;
const uint8_t *hfilter = bilinear_filters_2t[xoffset];
const __m128i hfilter_vec = _mm_set1_epi32(hfilter[0] | (hfilter[1] << 16));
for (i = 0; i < h + 1; ++i) {
for (j = 0; j < w; j += 8) {
const __m128i x = _mm_loadu_si128((__m128i *)&src[j]);
const __m128i y = _mm_loadu_si128((__m128i *)&src[j + 8]);
const __m128i z = _mm_alignr_epi8(y, x, 2);
const __m128i res = highbd_filter_block(x, z, hfilter_vec);
_mm_storeu_si128((__m128i *)&b[j], res);
}
src += src_stride;
b += w;
}
}
if (yoffset == 0) {
} else if (yoffset == 4) {
for (i = 0; i < h; ++i) {
for (j = 0; j < w; j += 8) {
__m128i x = _mm_loadu_si128((__m128i *)&dst[j]);
__m128i y = _mm_loadu_si128((__m128i *)&dst[j + w]);
_mm_storeu_si128((__m128i *)&dst[j], _mm_avg_epu16(x, y));
}
dst += w;
}
} else {
const uint8_t *vfilter = bilinear_filters_2t[yoffset];
const __m128i vfilter_vec = _mm_set1_epi32(vfilter[0] | (vfilter[1] << 16));
for (i = 0; i < h; ++i) {
for (j = 0; j < w; j += 8) {
const __m128i x = _mm_loadu_si128((__m128i *)&dst[j]);
const __m128i y = _mm_loadu_si128((__m128i *)&dst[j + w]);
const __m128i res = highbd_filter_block(x, y, vfilter_vec);
_mm_storeu_si128((__m128i *)&dst[j], res);
}
dst += w;
}
}
}
static inline __m128i highbd_filter_block_2rows(const __m128i *a0,
const __m128i *b0,
const __m128i *a1,
const __m128i *b1,
const __m128i *filter) {
__m128i v0 = _mm_unpacklo_epi16(*a0, *b0);
v0 = _mm_madd_epi16(v0, *filter);
v0 = xx_roundn_epu32(v0, FILTER_BITS);
__m128i v1 = _mm_unpacklo_epi16(*a1, *b1);
v1 = _mm_madd_epi16(v1, *filter);
v1 = xx_roundn_epu32(v1, FILTER_BITS);
return _mm_packs_epi32(v0, v1);
}
static void highbd_bilinear_filter4xh(const uint16_t *src, int src_stride,
int xoffset, int yoffset, uint16_t *dst,
int h) {
int i;
if (xoffset == 0) {
uint16_t *b = dst;
for (i = 0; i < h + 1; ++i) {
__m128i x = _mm_loadl_epi64((__m128i *)src);
_mm_storel_epi64((__m128i *)b, x);
src += src_stride;
b += 4;
}
} else if (xoffset == 4) {
uint16_t *b = dst;
for (i = 0; i < h + 1; ++i) {
__m128i x = _mm_loadu_si128((__m128i *)src);
__m128i z = _mm_srli_si128(x, 2);
_mm_storel_epi64((__m128i *)b, _mm_avg_epu16(x, z));
src += src_stride;
b += 4;
}
} else {
uint16_t *b = dst;
const uint8_t *hfilter = bilinear_filters_2t[xoffset];
const __m128i hfilter_vec = _mm_set1_epi32(hfilter[0] | (hfilter[1] << 16));
for (i = 0; i < h; i += 2) {
const __m128i x0 = _mm_loadu_si128((__m128i *)src);
const __m128i z0 = _mm_srli_si128(x0, 2);
const __m128i x1 = _mm_loadu_si128((__m128i *)&src[src_stride]);
const __m128i z1 = _mm_srli_si128(x1, 2);
const __m128i res =
highbd_filter_block_2rows(&x0, &z0, &x1, &z1, &hfilter_vec);
_mm_storeu_si128((__m128i *)b, res);
src += src_stride * 2;
b += 8;
}
__m128i x = _mm_loadu_si128((__m128i *)src);
__m128i z = _mm_srli_si128(x, 2);
__m128i v0 = _mm_unpacklo_epi16(x, z);
v0 = _mm_madd_epi16(v0, hfilter_vec);
v0 = xx_roundn_epu32(v0, FILTER_BITS);
_mm_storel_epi64((__m128i *)b, _mm_packs_epi32(v0, v0));
}
if (yoffset == 0) {
} else if (yoffset == 4) {
for (i = 0; i < h; ++i) {
__m128i x = _mm_loadl_epi64((__m128i *)dst);
__m128i y = _mm_loadl_epi64((__m128i *)&dst[4]);
_mm_storel_epi64((__m128i *)dst, _mm_avg_epu16(x, y));
dst += 4;
}
} else {
const uint8_t *vfilter = bilinear_filters_2t[yoffset];
const __m128i vfilter_vec = _mm_set1_epi32(vfilter[0] | (vfilter[1] << 16));
for (i = 0; i < h; i += 2) {
const __m128i x = _mm_loadl_epi64((__m128i *)dst);
const __m128i y = _mm_loadl_epi64((__m128i *)&dst[4]);
const __m128i z = _mm_loadl_epi64((__m128i *)&dst[8]);
const __m128i res =
highbd_filter_block_2rows(&x, &y, &y, &z, &vfilter_vec);
_mm_storeu_si128((__m128i *)dst, res);
dst += 8;
}
}
}
static void highbd_masked_variance(const uint16_t *src_ptr, int src_stride,
const uint16_t *a_ptr, int a_stride,
const uint16_t *b_ptr, int b_stride,
const uint8_t *m_ptr, int m_stride,
int width, int height, uint64_t *sse,
int *sum_) {
int x, y;
__m128i sum = _mm_setzero_si128(), sum_sq = _mm_setzero_si128();
const __m128i mask_max = _mm_set1_epi16((1 << AOM_BLEND_A64_ROUND_BITS));
const __m128i round_const =
_mm_set1_epi32((1 << AOM_BLEND_A64_ROUND_BITS) >> 1);
const __m128i zero = _mm_setzero_si128();
for (y = 0; y < height; y++) {
for (x = 0; x < width; x += 8) {
const __m128i src = _mm_loadu_si128((const __m128i *)&src_ptr[x]);
const __m128i a = _mm_loadu_si128((const __m128i *)&a_ptr[x]);
const __m128i b = _mm_loadu_si128((const __m128i *)&b_ptr[x]);
const __m128i m =
_mm_unpacklo_epi8(_mm_loadl_epi64((const __m128i *)&m_ptr[x]), zero);
const __m128i m_inv = _mm_sub_epi16(mask_max, m);
const __m128i data_l = _mm_unpacklo_epi16(a, b);
const __m128i mask_l = _mm_unpacklo_epi16(m, m_inv);
__m128i pred_l = _mm_madd_epi16(data_l, mask_l);
pred_l = _mm_srai_epi32(_mm_add_epi32(pred_l, round_const),
AOM_BLEND_A64_ROUND_BITS);
const __m128i data_r = _mm_unpackhi_epi16(a, b);
const __m128i mask_r = _mm_unpackhi_epi16(m, m_inv);
__m128i pred_r = _mm_madd_epi16(data_r, mask_r);
pred_r = _mm_srai_epi32(_mm_add_epi32(pred_r, round_const),
AOM_BLEND_A64_ROUND_BITS);
const __m128i src_l = _mm_unpacklo_epi16(src, zero);
const __m128i src_r = _mm_unpackhi_epi16(src, zero);
__m128i diff_l = _mm_sub_epi32(pred_l, src_l);
__m128i diff_r = _mm_sub_epi32(pred_r, src_r);
sum = _mm_add_epi32(sum, _mm_add_epi32(diff_l, diff_r));
const __m128i tmp = _mm_packs_epi32(diff_l, diff_r);
const __m128i prod = _mm_madd_epi16(tmp, tmp);
const __m128i sign = _mm_srai_epi32(prod, 31);
const __m128i tmp_0 = _mm_unpacklo_epi32(prod, sign);
const __m128i tmp_1 = _mm_unpackhi_epi32(prod, sign);
sum_sq = _mm_add_epi64(sum_sq, _mm_add_epi64(tmp_0, tmp_1));
}
src_ptr += src_stride;
a_ptr += a_stride;
b_ptr += b_stride;
m_ptr += m_stride;
}
sum = _mm_hadd_epi32(sum, zero);
sum = _mm_hadd_epi32(sum, zero);
*sum_ = _mm_cvtsi128_si32(sum);
sum_sq = _mm_add_epi64(sum_sq, _mm_srli_si128(sum_sq, 8));
_mm_storel_epi64((__m128i *)sse, sum_sq);
}
static void highbd_masked_variance4xh(const uint16_t *src_ptr, int src_stride,
const uint16_t *a_ptr,
const uint16_t *b_ptr,
const uint8_t *m_ptr, int m_stride,
int height, int *sse, int *sum_) {
int y;
__m128i sum = _mm_setzero_si128(), sum_sq = _mm_setzero_si128();
const __m128i mask_max = _mm_set1_epi16((1 << AOM_BLEND_A64_ROUND_BITS));
const __m128i round_const =
_mm_set1_epi32((1 << AOM_BLEND_A64_ROUND_BITS) >> 1);
const __m128i zero = _mm_setzero_si128();
for (y = 0; y < height; y += 2) {
__m128i src = _mm_unpacklo_epi64(
_mm_loadl_epi64((const __m128i *)src_ptr),
_mm_loadl_epi64((const __m128i *)&src_ptr[src_stride]));
const __m128i a = _mm_loadu_si128((const __m128i *)a_ptr);
const __m128i b = _mm_loadu_si128((const __m128i *)b_ptr);
const __m128i m = _mm_unpacklo_epi8(
_mm_unpacklo_epi32(_mm_cvtsi32_si128(*(const int *)m_ptr),
_mm_cvtsi32_si128(*(const int *)&m_ptr[m_stride])),
zero);
const __m128i m_inv = _mm_sub_epi16(mask_max, m);
const __m128i data_l = _mm_unpacklo_epi16(a, b);
const __m128i mask_l = _mm_unpacklo_epi16(m, m_inv);
__m128i pred_l = _mm_madd_epi16(data_l, mask_l);
pred_l = _mm_srai_epi32(_mm_add_epi32(pred_l, round_const),
AOM_BLEND_A64_ROUND_BITS);
const __m128i data_r = _mm_unpackhi_epi16(a, b);
const __m128i mask_r = _mm_unpackhi_epi16(m, m_inv);
__m128i pred_r = _mm_madd_epi16(data_r, mask_r);
pred_r = _mm_srai_epi32(_mm_add_epi32(pred_r, round_const),
AOM_BLEND_A64_ROUND_BITS);
const __m128i src_l = _mm_unpacklo_epi16(src, zero);
const __m128i src_r = _mm_unpackhi_epi16(src, zero);
__m128i diff_l = _mm_sub_epi32(pred_l, src_l);
__m128i diff_r = _mm_sub_epi32(pred_r, src_r);
sum = _mm_add_epi32(sum, _mm_add_epi32(diff_l, diff_r));
const __m128i tmp = _mm_packs_epi32(diff_l, diff_r);
const __m128i prod = _mm_madd_epi16(tmp, tmp);
sum_sq = _mm_add_epi32(sum_sq, prod);
src_ptr += src_stride * 2;
a_ptr += 8;
b_ptr += 8;
m_ptr += m_stride * 2;
}
sum = _mm_hadd_epi32(sum, sum_sq);
sum = _mm_hadd_epi32(sum, zero);
*sum_ = _mm_cvtsi128_si32(sum);
*sse = (unsigned int)_mm_cvtsi128_si32(_mm_srli_si128(sum, 4));
}
#endif
void aom_comp_mask_pred_ssse3(uint8_t *comp_pred, const uint8_t *pred,
int width, int height, const uint8_t *ref,
int ref_stride, const uint8_t *mask,
int mask_stride, int invert_mask) { … }