add code.
This commit is contained in:
@ -0,0 +1,188 @@
|
||||
/*
|
||||
* Copyright (c) 2020 The WebRTC project authors. All Rights Reserved.
|
||||
*
|
||||
* Use of this source code is governed by a BSD-style license
|
||||
* that can be found in the LICENSE file in the root of the source
|
||||
* tree. An additional intellectual property rights grant can be found
|
||||
* in the file PATENTS. All contributing project authors may
|
||||
* be found in the AUTHORS file in the root of the source tree.
|
||||
*/
|
||||
|
||||
#include <immintrin.h>
|
||||
|
||||
#include "modules/audio_processing/aec3/adaptive_fir_filter.h"
|
||||
#include "rtc_base/checks.h"
|
||||
|
||||
namespace webrtc {
|
||||
|
||||
namespace aec3 {
|
||||
|
||||
// Computes and stores the frequency response of the filter.
|
||||
void ComputeFrequencyResponse_Avx2(
|
||||
size_t num_partitions,
|
||||
const std::vector<std::vector<FftData>>& H,
|
||||
std::vector<std::array<float, kFftLengthBy2Plus1>>* H2) {
|
||||
for (auto& H2_ch : *H2) {
|
||||
H2_ch.fill(0.f);
|
||||
}
|
||||
|
||||
const size_t num_render_channels = H[0].size();
|
||||
RTC_DCHECK_EQ(H.size(), H2->capacity());
|
||||
for (size_t p = 0; p < num_partitions; ++p) {
|
||||
RTC_DCHECK_EQ(kFftLengthBy2Plus1, (*H2)[p].size());
|
||||
auto& H2_p = (*H2)[p];
|
||||
for (size_t ch = 0; ch < num_render_channels; ++ch) {
|
||||
const FftData& H_p_ch = H[p][ch];
|
||||
for (size_t j = 0; j < kFftLengthBy2; j += 8) {
|
||||
__m256 re = _mm256_loadu_ps(&H_p_ch.re[j]);
|
||||
__m256 re2 = _mm256_mul_ps(re, re);
|
||||
__m256 im = _mm256_loadu_ps(&H_p_ch.im[j]);
|
||||
re2 = _mm256_fmadd_ps(im, im, re2);
|
||||
__m256 H2_k_j = _mm256_loadu_ps(&H2_p[j]);
|
||||
H2_k_j = _mm256_max_ps(H2_k_j, re2);
|
||||
_mm256_storeu_ps(&H2_p[j], H2_k_j);
|
||||
}
|
||||
float H2_new = H_p_ch.re[kFftLengthBy2] * H_p_ch.re[kFftLengthBy2] +
|
||||
H_p_ch.im[kFftLengthBy2] * H_p_ch.im[kFftLengthBy2];
|
||||
H2_p[kFftLengthBy2] = std::max(H2_p[kFftLengthBy2], H2_new);
|
||||
}
|
||||
}
|
||||
}
|
||||
|
||||
// Adapts the filter partitions.
|
||||
void AdaptPartitions_Avx2(const RenderBuffer& render_buffer,
|
||||
const FftData& G,
|
||||
size_t num_partitions,
|
||||
std::vector<std::vector<FftData>>* H) {
|
||||
rtc::ArrayView<const std::vector<FftData>> render_buffer_data =
|
||||
render_buffer.GetFftBuffer();
|
||||
const size_t num_render_channels = render_buffer_data[0].size();
|
||||
const size_t lim1 = std::min(
|
||||
render_buffer_data.size() - render_buffer.Position(), num_partitions);
|
||||
const size_t lim2 = num_partitions;
|
||||
constexpr size_t kNumEightBinBands = kFftLengthBy2 / 8;
|
||||
|
||||
size_t X_partition = render_buffer.Position();
|
||||
size_t limit = lim1;
|
||||
size_t p = 0;
|
||||
do {
|
||||
for (; p < limit; ++p, ++X_partition) {
|
||||
for (size_t ch = 0; ch < num_render_channels; ++ch) {
|
||||
FftData& H_p_ch = (*H)[p][ch];
|
||||
const FftData& X = render_buffer_data[X_partition][ch];
|
||||
|
||||
for (size_t k = 0, n = 0; n < kNumEightBinBands; ++n, k += 8) {
|
||||
const __m256 G_re = _mm256_loadu_ps(&G.re[k]);
|
||||
const __m256 G_im = _mm256_loadu_ps(&G.im[k]);
|
||||
const __m256 X_re = _mm256_loadu_ps(&X.re[k]);
|
||||
const __m256 X_im = _mm256_loadu_ps(&X.im[k]);
|
||||
const __m256 H_re = _mm256_loadu_ps(&H_p_ch.re[k]);
|
||||
const __m256 H_im = _mm256_loadu_ps(&H_p_ch.im[k]);
|
||||
const __m256 a = _mm256_mul_ps(X_re, G_re);
|
||||
const __m256 b = _mm256_mul_ps(X_im, G_im);
|
||||
const __m256 c = _mm256_mul_ps(X_re, G_im);
|
||||
const __m256 d = _mm256_mul_ps(X_im, G_re);
|
||||
const __m256 e = _mm256_add_ps(a, b);
|
||||
const __m256 f = _mm256_sub_ps(c, d);
|
||||
const __m256 g = _mm256_add_ps(H_re, e);
|
||||
const __m256 h = _mm256_add_ps(H_im, f);
|
||||
_mm256_storeu_ps(&H_p_ch.re[k], g);
|
||||
_mm256_storeu_ps(&H_p_ch.im[k], h);
|
||||
}
|
||||
}
|
||||
}
|
||||
X_partition = 0;
|
||||
limit = lim2;
|
||||
} while (p < lim2);
|
||||
|
||||
X_partition = render_buffer.Position();
|
||||
limit = lim1;
|
||||
p = 0;
|
||||
do {
|
||||
for (; p < limit; ++p, ++X_partition) {
|
||||
for (size_t ch = 0; ch < num_render_channels; ++ch) {
|
||||
FftData& H_p_ch = (*H)[p][ch];
|
||||
const FftData& X = render_buffer_data[X_partition][ch];
|
||||
|
||||
H_p_ch.re[kFftLengthBy2] += X.re[kFftLengthBy2] * G.re[kFftLengthBy2] +
|
||||
X.im[kFftLengthBy2] * G.im[kFftLengthBy2];
|
||||
H_p_ch.im[kFftLengthBy2] += X.re[kFftLengthBy2] * G.im[kFftLengthBy2] -
|
||||
X.im[kFftLengthBy2] * G.re[kFftLengthBy2];
|
||||
}
|
||||
}
|
||||
|
||||
X_partition = 0;
|
||||
limit = lim2;
|
||||
} while (p < lim2);
|
||||
}
|
||||
|
||||
// Produces the filter output (AVX2 variant).
|
||||
void ApplyFilter_Avx2(const RenderBuffer& render_buffer,
|
||||
size_t num_partitions,
|
||||
const std::vector<std::vector<FftData>>& H,
|
||||
FftData* S) {
|
||||
RTC_DCHECK_GE(H.size(), H.size() - 1);
|
||||
S->re.fill(0.f);
|
||||
S->im.fill(0.f);
|
||||
|
||||
rtc::ArrayView<const std::vector<FftData>> render_buffer_data =
|
||||
render_buffer.GetFftBuffer();
|
||||
const size_t num_render_channels = render_buffer_data[0].size();
|
||||
const size_t lim1 = std::min(
|
||||
render_buffer_data.size() - render_buffer.Position(), num_partitions);
|
||||
const size_t lim2 = num_partitions;
|
||||
constexpr size_t kNumEightBinBands = kFftLengthBy2 / 8;
|
||||
|
||||
size_t X_partition = render_buffer.Position();
|
||||
size_t p = 0;
|
||||
size_t limit = lim1;
|
||||
do {
|
||||
for (; p < limit; ++p, ++X_partition) {
|
||||
for (size_t ch = 0; ch < num_render_channels; ++ch) {
|
||||
const FftData& H_p_ch = H[p][ch];
|
||||
const FftData& X = render_buffer_data[X_partition][ch];
|
||||
for (size_t k = 0, n = 0; n < kNumEightBinBands; ++n, k += 8) {
|
||||
const __m256 X_re = _mm256_loadu_ps(&X.re[k]);
|
||||
const __m256 X_im = _mm256_loadu_ps(&X.im[k]);
|
||||
const __m256 H_re = _mm256_loadu_ps(&H_p_ch.re[k]);
|
||||
const __m256 H_im = _mm256_loadu_ps(&H_p_ch.im[k]);
|
||||
const __m256 S_re = _mm256_loadu_ps(&S->re[k]);
|
||||
const __m256 S_im = _mm256_loadu_ps(&S->im[k]);
|
||||
const __m256 a = _mm256_mul_ps(X_re, H_re);
|
||||
const __m256 b = _mm256_mul_ps(X_im, H_im);
|
||||
const __m256 c = _mm256_mul_ps(X_re, H_im);
|
||||
const __m256 d = _mm256_mul_ps(X_im, H_re);
|
||||
const __m256 e = _mm256_sub_ps(a, b);
|
||||
const __m256 f = _mm256_add_ps(c, d);
|
||||
const __m256 g = _mm256_add_ps(S_re, e);
|
||||
const __m256 h = _mm256_add_ps(S_im, f);
|
||||
_mm256_storeu_ps(&S->re[k], g);
|
||||
_mm256_storeu_ps(&S->im[k], h);
|
||||
}
|
||||
}
|
||||
}
|
||||
limit = lim2;
|
||||
X_partition = 0;
|
||||
} while (p < lim2);
|
||||
|
||||
X_partition = render_buffer.Position();
|
||||
p = 0;
|
||||
limit = lim1;
|
||||
do {
|
||||
for (; p < limit; ++p, ++X_partition) {
|
||||
for (size_t ch = 0; ch < num_render_channels; ++ch) {
|
||||
const FftData& H_p_ch = H[p][ch];
|
||||
const FftData& X = render_buffer_data[X_partition][ch];
|
||||
S->re[kFftLengthBy2] += X.re[kFftLengthBy2] * H_p_ch.re[kFftLengthBy2] -
|
||||
X.im[kFftLengthBy2] * H_p_ch.im[kFftLengthBy2];
|
||||
S->im[kFftLengthBy2] += X.re[kFftLengthBy2] * H_p_ch.im[kFftLengthBy2] +
|
||||
X.im[kFftLengthBy2] * H_p_ch.re[kFftLengthBy2];
|
||||
}
|
||||
}
|
||||
limit = lim2;
|
||||
X_partition = 0;
|
||||
} while (p < lim2);
|
||||
}
|
||||
|
||||
} // namespace aec3
|
||||
} // namespace webrtc
|
@ -0,0 +1,37 @@
|
||||
/*
|
||||
* Copyright (c) 2020 The WebRTC project authors. All Rights Reserved.
|
||||
*
|
||||
* Use of this source code is governed by a BSD-style license
|
||||
* that can be found in the LICENSE file in the root of the source
|
||||
* tree. An additional intellectual property rights grant can be found
|
||||
* in the file PATENTS. All contributing project authors may
|
||||
* be found in the AUTHORS file in the root of the source tree.
|
||||
*/
|
||||
|
||||
#include <immintrin.h>
|
||||
|
||||
#include "modules/audio_processing/aec3/adaptive_fir_filter_erl.h"
|
||||
|
||||
namespace webrtc {
|
||||
|
||||
namespace aec3 {
|
||||
|
||||
// Computes and stores the echo return loss estimate of the filter, which is the
|
||||
// sum of the partition frequency responses.
|
||||
void ErlComputer_AVX2(
|
||||
const std::vector<std::array<float, kFftLengthBy2Plus1>>& H2,
|
||||
rtc::ArrayView<float> erl) {
|
||||
std::fill(erl.begin(), erl.end(), 0.f);
|
||||
for (auto& H2_j : H2) {
|
||||
for (size_t k = 0; k < kFftLengthBy2; k += 8) {
|
||||
const __m256 H2_j_k = _mm256_loadu_ps(&H2_j[k]);
|
||||
__m256 erl_k = _mm256_loadu_ps(&erl[k]);
|
||||
erl_k = _mm256_add_ps(erl_k, H2_j_k);
|
||||
_mm256_storeu_ps(&erl[k], erl_k);
|
||||
}
|
||||
erl[kFftLengthBy2] += H2_j[kFftLengthBy2];
|
||||
}
|
||||
}
|
||||
|
||||
} // namespace aec3
|
||||
} // namespace webrtc
|
32
VocieProcess/modules/audio_processing/aec3/fft_data_avx2.cc
Normal file
32
VocieProcess/modules/audio_processing/aec3/fft_data_avx2.cc
Normal file
@ -0,0 +1,32 @@
|
||||
/*
|
||||
* Copyright (c) 2020 The WebRTC project authors. All Rights Reserved.
|
||||
*
|
||||
* Use of this source code is governed by a BSD-style license
|
||||
* that can be found in the LICENSE file in the root of the source
|
||||
* tree. An additional intellectual property rights grant can be found
|
||||
* in the file PATENTS. All contributing project authors may
|
||||
* be found in the AUTHORS file in the root of the source tree.
|
||||
*/
|
||||
|
||||
#include <immintrin.h>
|
||||
|
||||
#include "api/array_view.h"
|
||||
#include "modules/audio_processing/aec3/fft_data.h"
|
||||
|
||||
namespace webrtc {
|
||||
|
||||
// Computes the power spectrum of the data.
|
||||
void FftData::SpectrumAVX2(rtc::ArrayView<float> power_spectrum) const {
|
||||
RTC_DCHECK_EQ(kFftLengthBy2Plus1, power_spectrum.size());
|
||||
for (size_t k = 0; k < kFftLengthBy2; k += 8) {
|
||||
__m256 r = _mm256_loadu_ps(&re[k]);
|
||||
__m256 i = _mm256_loadu_ps(&im[k]);
|
||||
__m256 ii = _mm256_mul_ps(i, i);
|
||||
ii = _mm256_fmadd_ps(r, r, ii);
|
||||
_mm256_storeu_ps(&power_spectrum[k], ii);
|
||||
}
|
||||
power_spectrum[kFftLengthBy2] = re[kFftLengthBy2] * re[kFftLengthBy2] +
|
||||
im[kFftLengthBy2] * im[kFftLengthBy2];
|
||||
}
|
||||
|
||||
} // namespace webrtc
|
@ -0,0 +1,261 @@
|
||||
/*
|
||||
* Copyright (c) 2020 The WebRTC project authors. All Rights Reserved.
|
||||
*
|
||||
* Use of this source code is governed by a BSD-style license
|
||||
* that can be found in the LICENSE file in the root of the source
|
||||
* tree. An additional intellectual property rights grant can be found
|
||||
* in the file PATENTS. All contributing project authors may
|
||||
* be found in the AUTHORS file in the root of the source tree.
|
||||
*/
|
||||
|
||||
#include <immintrin.h>
|
||||
|
||||
#include "modules/audio_processing/aec3/matched_filter.h"
|
||||
#include "rtc_base/checks.h"
|
||||
|
||||
namespace webrtc {
|
||||
namespace aec3 {
|
||||
|
||||
// Let ha denote the horizontal of a, and hb the horizontal sum of b
|
||||
// returns [ha, hb, ha, hb]
|
||||
inline __m128 hsum_ab(__m256 a, __m256 b) {
|
||||
__m256 s_256 = _mm256_hadd_ps(a, b);
|
||||
const __m256i mask = _mm256_set_epi32(7, 6, 3, 2, 5, 4, 1, 0);
|
||||
s_256 = _mm256_permutevar8x32_ps(s_256, mask);
|
||||
__m128 s = _mm_hadd_ps(_mm256_extractf128_ps(s_256, 0),
|
||||
_mm256_extractf128_ps(s_256, 1));
|
||||
s = _mm_hadd_ps(s, s);
|
||||
return s;
|
||||
}
|
||||
|
||||
void MatchedFilterCore_AccumulatedError_AVX2(
|
||||
size_t x_start_index,
|
||||
float x2_sum_threshold,
|
||||
float smoothing,
|
||||
rtc::ArrayView<const float> x,
|
||||
rtc::ArrayView<const float> y,
|
||||
rtc::ArrayView<float> h,
|
||||
bool* filters_updated,
|
||||
float* error_sum,
|
||||
rtc::ArrayView<float> accumulated_error,
|
||||
rtc::ArrayView<float> scratch_memory) {
|
||||
const int h_size = static_cast<int>(h.size());
|
||||
const int x_size = static_cast<int>(x.size());
|
||||
RTC_DCHECK_EQ(0, h_size % 16);
|
||||
std::fill(accumulated_error.begin(), accumulated_error.end(), 0.0f);
|
||||
|
||||
// Process for all samples in the sub-block.
|
||||
for (size_t i = 0; i < y.size(); ++i) {
|
||||
// Apply the matched filter as filter * x, and compute x * x.
|
||||
RTC_DCHECK_GT(x_size, x_start_index);
|
||||
const int chunk1 =
|
||||
std::min(h_size, static_cast<int>(x_size - x_start_index));
|
||||
if (chunk1 != h_size) {
|
||||
const int chunk2 = h_size - chunk1;
|
||||
std::copy(x.begin() + x_start_index, x.end(), scratch_memory.begin());
|
||||
std::copy(x.begin(), x.begin() + chunk2, scratch_memory.begin() + chunk1);
|
||||
}
|
||||
const float* x_p =
|
||||
chunk1 != h_size ? scratch_memory.data() : &x[x_start_index];
|
||||
const float* h_p = &h[0];
|
||||
float* a_p = &accumulated_error[0];
|
||||
__m256 s_inst_hadd_256;
|
||||
__m256 s_inst_256;
|
||||
__m256 s_inst_256_8;
|
||||
__m256 x2_sum_256 = _mm256_set1_ps(0);
|
||||
__m256 x2_sum_256_8 = _mm256_set1_ps(0);
|
||||
__m128 e_128;
|
||||
float x2_sum = 0.0f;
|
||||
float s_acum = 0;
|
||||
const int limit_by_16 = h_size >> 4;
|
||||
for (int k = limit_by_16; k > 0; --k, h_p += 16, x_p += 16, a_p += 4) {
|
||||
// Load the data into 256 bit vectors.
|
||||
__m256 x_k = _mm256_loadu_ps(x_p);
|
||||
__m256 h_k = _mm256_loadu_ps(h_p);
|
||||
__m256 x_k_8 = _mm256_loadu_ps(x_p + 8);
|
||||
__m256 h_k_8 = _mm256_loadu_ps(h_p + 8);
|
||||
// Compute and accumulate x * x and h * x.
|
||||
x2_sum_256 = _mm256_fmadd_ps(x_k, x_k, x2_sum_256);
|
||||
x2_sum_256_8 = _mm256_fmadd_ps(x_k_8, x_k_8, x2_sum_256_8);
|
||||
s_inst_256 = _mm256_mul_ps(h_k, x_k);
|
||||
s_inst_256_8 = _mm256_mul_ps(h_k_8, x_k_8);
|
||||
s_inst_hadd_256 = _mm256_hadd_ps(s_inst_256, s_inst_256_8);
|
||||
s_inst_hadd_256 = _mm256_hadd_ps(s_inst_hadd_256, s_inst_hadd_256);
|
||||
s_acum += s_inst_hadd_256[0];
|
||||
e_128[0] = s_acum - y[i];
|
||||
s_acum += s_inst_hadd_256[4];
|
||||
e_128[1] = s_acum - y[i];
|
||||
s_acum += s_inst_hadd_256[1];
|
||||
e_128[2] = s_acum - y[i];
|
||||
s_acum += s_inst_hadd_256[5];
|
||||
e_128[3] = s_acum - y[i];
|
||||
|
||||
__m128 accumulated_error = _mm_load_ps(a_p);
|
||||
accumulated_error = _mm_fmadd_ps(e_128, e_128, accumulated_error);
|
||||
_mm_storeu_ps(a_p, accumulated_error);
|
||||
}
|
||||
// Sum components together.
|
||||
x2_sum_256 = _mm256_add_ps(x2_sum_256, x2_sum_256_8);
|
||||
__m128 x2_sum_128 = _mm_add_ps(_mm256_extractf128_ps(x2_sum_256, 0),
|
||||
_mm256_extractf128_ps(x2_sum_256, 1));
|
||||
// Combine the accumulated vector and scalar values.
|
||||
float* v = reinterpret_cast<float*>(&x2_sum_128);
|
||||
x2_sum += v[0] + v[1] + v[2] + v[3];
|
||||
|
||||
// Compute the matched filter error.
|
||||
float e = y[i] - s_acum;
|
||||
const bool saturation = y[i] >= 32000.f || y[i] <= -32000.f;
|
||||
(*error_sum) += e * e;
|
||||
|
||||
// Update the matched filter estimate in an NLMS manner.
|
||||
if (x2_sum > x2_sum_threshold && !saturation) {
|
||||
RTC_DCHECK_LT(0.f, x2_sum);
|
||||
const float alpha = smoothing * e / x2_sum;
|
||||
const __m256 alpha_256 = _mm256_set1_ps(alpha);
|
||||
|
||||
// filter = filter + smoothing * (y - filter * x) * x / x * x.
|
||||
float* h_p = &h[0];
|
||||
const float* x_p =
|
||||
chunk1 != h_size ? scratch_memory.data() : &x[x_start_index];
|
||||
// Perform 256 bit vector operations.
|
||||
const int limit_by_8 = h_size >> 3;
|
||||
for (int k = limit_by_8; k > 0; --k, h_p += 8, x_p += 8) {
|
||||
// Load the data into 256 bit vectors.
|
||||
__m256 h_k = _mm256_loadu_ps(h_p);
|
||||
__m256 x_k = _mm256_loadu_ps(x_p);
|
||||
// Compute h = h + alpha * x.
|
||||
h_k = _mm256_fmadd_ps(x_k, alpha_256, h_k);
|
||||
|
||||
// Store the result.
|
||||
_mm256_storeu_ps(h_p, h_k);
|
||||
}
|
||||
*filters_updated = true;
|
||||
}
|
||||
|
||||
x_start_index = x_start_index > 0 ? x_start_index - 1 : x_size - 1;
|
||||
}
|
||||
}
|
||||
|
||||
void MatchedFilterCore_AVX2(size_t x_start_index,
|
||||
float x2_sum_threshold,
|
||||
float smoothing,
|
||||
rtc::ArrayView<const float> x,
|
||||
rtc::ArrayView<const float> y,
|
||||
rtc::ArrayView<float> h,
|
||||
bool* filters_updated,
|
||||
float* error_sum,
|
||||
bool compute_accumulated_error,
|
||||
rtc::ArrayView<float> accumulated_error,
|
||||
rtc::ArrayView<float> scratch_memory) {
|
||||
if (compute_accumulated_error) {
|
||||
return MatchedFilterCore_AccumulatedError_AVX2(
|
||||
x_start_index, x2_sum_threshold, smoothing, x, y, h, filters_updated,
|
||||
error_sum, accumulated_error, scratch_memory);
|
||||
}
|
||||
const int h_size = static_cast<int>(h.size());
|
||||
const int x_size = static_cast<int>(x.size());
|
||||
RTC_DCHECK_EQ(0, h_size % 8);
|
||||
|
||||
// Process for all samples in the sub-block.
|
||||
for (size_t i = 0; i < y.size(); ++i) {
|
||||
// Apply the matched filter as filter * x, and compute x * x.
|
||||
|
||||
RTC_DCHECK_GT(x_size, x_start_index);
|
||||
const float* x_p = &x[x_start_index];
|
||||
const float* h_p = &h[0];
|
||||
|
||||
// Initialize values for the accumulation.
|
||||
__m256 s_256 = _mm256_set1_ps(0);
|
||||
__m256 s_256_8 = _mm256_set1_ps(0);
|
||||
__m256 x2_sum_256 = _mm256_set1_ps(0);
|
||||
__m256 x2_sum_256_8 = _mm256_set1_ps(0);
|
||||
float x2_sum = 0.f;
|
||||
float s = 0;
|
||||
|
||||
// Compute loop chunk sizes until, and after, the wraparound of the circular
|
||||
// buffer for x.
|
||||
const int chunk1 =
|
||||
std::min(h_size, static_cast<int>(x_size - x_start_index));
|
||||
|
||||
// Perform the loop in two chunks.
|
||||
const int chunk2 = h_size - chunk1;
|
||||
for (int limit : {chunk1, chunk2}) {
|
||||
// Perform 256 bit vector operations.
|
||||
const int limit_by_16 = limit >> 4;
|
||||
for (int k = limit_by_16; k > 0; --k, h_p += 16, x_p += 16) {
|
||||
// Load the data into 256 bit vectors.
|
||||
__m256 x_k = _mm256_loadu_ps(x_p);
|
||||
__m256 h_k = _mm256_loadu_ps(h_p);
|
||||
__m256 x_k_8 = _mm256_loadu_ps(x_p + 8);
|
||||
__m256 h_k_8 = _mm256_loadu_ps(h_p + 8);
|
||||
// Compute and accumulate x * x and h * x.
|
||||
x2_sum_256 = _mm256_fmadd_ps(x_k, x_k, x2_sum_256);
|
||||
x2_sum_256_8 = _mm256_fmadd_ps(x_k_8, x_k_8, x2_sum_256_8);
|
||||
s_256 = _mm256_fmadd_ps(h_k, x_k, s_256);
|
||||
s_256_8 = _mm256_fmadd_ps(h_k_8, x_k_8, s_256_8);
|
||||
}
|
||||
|
||||
// Perform non-vector operations for any remaining items.
|
||||
for (int k = limit - limit_by_16 * 16; k > 0; --k, ++h_p, ++x_p) {
|
||||
const float x_k = *x_p;
|
||||
x2_sum += x_k * x_k;
|
||||
s += *h_p * x_k;
|
||||
}
|
||||
|
||||
x_p = &x[0];
|
||||
}
|
||||
|
||||
// Sum components together.
|
||||
x2_sum_256 = _mm256_add_ps(x2_sum_256, x2_sum_256_8);
|
||||
s_256 = _mm256_add_ps(s_256, s_256_8);
|
||||
__m128 sum = hsum_ab(x2_sum_256, s_256);
|
||||
x2_sum += sum[0];
|
||||
s += sum[1];
|
||||
|
||||
// Compute the matched filter error.
|
||||
float e = y[i] - s;
|
||||
const bool saturation = y[i] >= 32000.f || y[i] <= -32000.f;
|
||||
(*error_sum) += e * e;
|
||||
|
||||
// Update the matched filter estimate in an NLMS manner.
|
||||
if (x2_sum > x2_sum_threshold && !saturation) {
|
||||
RTC_DCHECK_LT(0.f, x2_sum);
|
||||
const float alpha = smoothing * e / x2_sum;
|
||||
const __m256 alpha_256 = _mm256_set1_ps(alpha);
|
||||
|
||||
// filter = filter + smoothing * (y - filter * x) * x / x * x.
|
||||
float* h_p = &h[0];
|
||||
x_p = &x[x_start_index];
|
||||
|
||||
// Perform the loop in two chunks.
|
||||
for (int limit : {chunk1, chunk2}) {
|
||||
// Perform 256 bit vector operations.
|
||||
const int limit_by_8 = limit >> 3;
|
||||
for (int k = limit_by_8; k > 0; --k, h_p += 8, x_p += 8) {
|
||||
// Load the data into 256 bit vectors.
|
||||
__m256 h_k = _mm256_loadu_ps(h_p);
|
||||
__m256 x_k = _mm256_loadu_ps(x_p);
|
||||
// Compute h = h + alpha * x.
|
||||
h_k = _mm256_fmadd_ps(x_k, alpha_256, h_k);
|
||||
|
||||
// Store the result.
|
||||
_mm256_storeu_ps(h_p, h_k);
|
||||
}
|
||||
|
||||
// Perform non-vector operations for any remaining items.
|
||||
for (int k = limit - limit_by_8 * 8; k > 0; --k, ++h_p, ++x_p) {
|
||||
*h_p += alpha * *x_p;
|
||||
}
|
||||
|
||||
x_p = &x[0];
|
||||
}
|
||||
|
||||
*filters_updated = true;
|
||||
}
|
||||
|
||||
x_start_index = x_start_index > 0 ? x_start_index - 1 : x_size - 1;
|
||||
}
|
||||
}
|
||||
|
||||
} // namespace aec3
|
||||
} // namespace webrtc
|
@ -0,0 +1,81 @@
|
||||
/*
|
||||
* Copyright (c) 2020 The WebRTC project authors. All Rights Reserved.
|
||||
*
|
||||
* Use of this source code is governed by a BSD-style license
|
||||
* that can be found in the LICENSE file in the root of the source
|
||||
* tree. An additional intellectual property rights grant can be found
|
||||
* in the file PATENTS. All contributing project authors may
|
||||
* be found in the AUTHORS file in the root of the source tree.
|
||||
*/
|
||||
|
||||
#include <immintrin.h>
|
||||
#include <math.h>
|
||||
|
||||
#include "api/array_view.h"
|
||||
#include "modules/audio_processing/aec3/vector_math.h"
|
||||
#include "rtc_base/checks.h"
|
||||
|
||||
namespace webrtc {
|
||||
namespace aec3 {
|
||||
|
||||
// Elementwise square root.
|
||||
void VectorMath::SqrtAVX2(rtc::ArrayView<float> x) {
|
||||
const int x_size = static_cast<int>(x.size());
|
||||
const int vector_limit = x_size >> 3;
|
||||
|
||||
int j = 0;
|
||||
for (; j < vector_limit * 8; j += 8) {
|
||||
__m256 g = _mm256_loadu_ps(&x[j]);
|
||||
g = _mm256_sqrt_ps(g);
|
||||
_mm256_storeu_ps(&x[j], g);
|
||||
}
|
||||
|
||||
for (; j < x_size; ++j) {
|
||||
x[j] = sqrtf(x[j]);
|
||||
}
|
||||
}
|
||||
|
||||
// Elementwise vector multiplication z = x * y.
|
||||
void VectorMath::MultiplyAVX2(rtc::ArrayView<const float> x,
|
||||
rtc::ArrayView<const float> y,
|
||||
rtc::ArrayView<float> z) {
|
||||
RTC_DCHECK_EQ(z.size(), x.size());
|
||||
RTC_DCHECK_EQ(z.size(), y.size());
|
||||
const int x_size = static_cast<int>(x.size());
|
||||
const int vector_limit = x_size >> 3;
|
||||
|
||||
int j = 0;
|
||||
for (; j < vector_limit * 8; j += 8) {
|
||||
const __m256 x_j = _mm256_loadu_ps(&x[j]);
|
||||
const __m256 y_j = _mm256_loadu_ps(&y[j]);
|
||||
const __m256 z_j = _mm256_mul_ps(x_j, y_j);
|
||||
_mm256_storeu_ps(&z[j], z_j);
|
||||
}
|
||||
|
||||
for (; j < x_size; ++j) {
|
||||
z[j] = x[j] * y[j];
|
||||
}
|
||||
}
|
||||
|
||||
// Elementwise vector accumulation z += x.
|
||||
void VectorMath::AccumulateAVX2(rtc::ArrayView<const float> x,
|
||||
rtc::ArrayView<float> z) {
|
||||
RTC_DCHECK_EQ(z.size(), x.size());
|
||||
const int x_size = static_cast<int>(x.size());
|
||||
const int vector_limit = x_size >> 3;
|
||||
|
||||
int j = 0;
|
||||
for (; j < vector_limit * 8; j += 8) {
|
||||
const __m256 x_j = _mm256_loadu_ps(&x[j]);
|
||||
__m256 z_j = _mm256_loadu_ps(&z[j]);
|
||||
z_j = _mm256_add_ps(x_j, z_j);
|
||||
_mm256_storeu_ps(&z[j], z_j);
|
||||
}
|
||||
|
||||
for (; j < x_size; ++j) {
|
||||
z[j] += x[j];
|
||||
}
|
||||
}
|
||||
|
||||
} // namespace aec3
|
||||
} // namespace webrtc
|
Reference in New Issue
Block a user