1
0
mirror of https://github.com/f4exb/sdrangel.git synced 2024-09-21 12:26:34 -04:00
sdrangel/wdsp/snba.cpp

845 lines
19 KiB
C++
Raw Normal View History

2024-06-16 05:31:13 -04:00
/* snb.c
This file is part of a program that implements a Software-Defined Radio.
Copyright (C) 2015, 2016 Warren Pratt, NR0V
Copyright (C) 2024 Edouard Griffiths, F4EXB Adapted to SDRangel
This program is free software; you can redistribute it and/or
modify it under the terms of the GNU General Public License
as published by the Free Software Foundation; either version 2
of the License, or (at your option) any later version.
This program is distributed in the hope that it will be useful,
but WITHOUT ANY WARRANTY; without even the implied warranty of
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
GNU General Public License for more details.
You should have received a copy of the GNU General Public License
along with this program; if not, write to the Free Software
Foundation, Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301, USA.
The author can be reached by email at
warren@wpratt.com
*/
2024-08-03 05:05:12 -04:00
#include <array>
2024-06-16 05:31:13 -04:00
#include "comm.hpp"
#include "resample.hpp"
#include "lmath.hpp"
#include "firmin.hpp"
#include "nbp.hpp"
#include "amd.hpp"
#include "anf.hpp"
#include "anr.hpp"
#include "emnr.hpp"
2024-07-02 18:52:16 -04:00
#include "snba.hpp"
2024-06-16 05:31:13 -04:00
namespace WDSP {
2024-08-03 05:05:12 -04:00
SNBA::Exec::Exec(int xsize, int _asize, int _npasses) :
asize(_asize),
npasses(_npasses)
{
a.resize(xsize);
v.resize(xsize);
detout.resize(xsize);
savex.resize(xsize);
xHout.resize(xsize);
unfixed.resize(xsize);
}
void SNBA::Exec::fluxh()
{
std::fill (a.begin(), a.end(), 0);
std::fill (v.begin(), v.end(), 0);
std::fill (detout.begin(), detout.end(), 0);
std::fill (savex.begin(), savex.end(), 0);
std::fill (xHout.begin(), xHout.end(), 0);
std::fill (unfixed.begin(), unfixed.end(), 0);
}
SNBA::Det::Det(
int _xsize,
double _k1,
double _k2,
int _b,
int _pre,
int _post
) :
k1(_k1),
k2(_k2),
b(_b),
pre(_pre),
post(_post)
{
vp.resize(_xsize);
vpwr.resize(_xsize);
}
void SNBA::Det::flush()
{
std::fill(vp.begin(), vp.end(), 0);
std::fill(vpwr.begin(), vpwr.end(), 0);
}
SNBA::Wrk::Wrk(
int xsize,
int asize
) :
xHat_a1rows_max(xsize + asize),
xHat_a2cols_max(xsize + 2 * asize)
{
xHat_r.resize(xsize);
xHat_ATAI.resize(xsize * xsize);
xHat_A1.resize(xHat_a1rows_max * xsize);
xHat_A2.resize(xHat_a1rows_max * xHat_a2cols_max);
xHat_P1.resize(xsize * xHat_a2cols_max);
xHat_P2.resize(xsize);
trI_y.resize(xsize - 1);
trI_v.resize(xsize - 1);
dR_z.resize(xsize - 2);
asolve_r.resize(asize + 1);
asolve_z.resize(asize + 1);
}
void SNBA::calc()
2024-06-16 05:31:13 -04:00
{
if (inrate >= internalrate)
isize = bsize / (inrate / internalrate);
2024-06-16 05:31:13 -04:00
else
isize = bsize * (internalrate / inrate);
2024-07-02 18:52:16 -04:00
2024-08-10 17:46:47 -04:00
inbuff.resize(isize * 2);
outbuff.resize(isize * 2);
2024-07-02 18:52:16 -04:00
if (inrate != internalrate)
resamprun = 1;
2024-06-16 05:31:13 -04:00
else
resamprun = 0;
inresamp = new RESAMPLE(
resamprun,
bsize,
in,
2024-08-10 17:46:47 -04:00
inbuff.data(),
inrate,
internalrate,
2024-07-02 19:03:49 -04:00
0.0,
0,
2.0
);
inresamp->setFCLow(250.0);
outresamp = new RESAMPLE(
resamprun,
isize,
2024-08-10 17:46:47 -04:00
outbuff.data(),
out,
internalrate,
inrate,
2024-07-02 19:03:49 -04:00
0.0,
0,
2.0
);
outresamp->setFCLow(200.0);
incr = xsize / ovrlp;
2024-07-02 18:52:16 -04:00
if (incr > isize)
iasize = incr;
2024-06-16 05:31:13 -04:00
else
iasize = isize;
2024-07-02 18:52:16 -04:00
iainidx = 0;
iaoutidx = 0;
2024-08-03 05:05:12 -04:00
inaccum.resize(iasize * 2);
nsamps = 0;
2024-07-02 18:52:16 -04:00
if (incr > isize)
2024-06-16 05:31:13 -04:00
{
oasize = incr;
oainidx = 0;
oaoutidx = isize;
2024-06-16 05:31:13 -04:00
}
else
{
oasize = isize;
oainidx = 0;
oaoutidx = 0;
2024-06-16 05:31:13 -04:00
}
2024-07-02 18:52:16 -04:00
init_oaoutidx = oaoutidx;
2024-08-03 05:05:12 -04:00
outaccum.resize(oasize * 2);
2024-06-16 05:31:13 -04:00
}
SNBA::SNBA(
int _run,
float* _in,
float* _out,
int _inrate,
int _internalrate,
int _bsize,
int _ovrlp,
int _xsize,
int _asize,
int _npasses,
double _k1,
double _k2,
int _b,
int _pre,
int _post,
double _pmultmin,
double _out_low_cut,
double _out_high_cut
) :
run(_run),
in(_in),
out(_out),
inrate(_inrate),
internalrate(_internalrate),
bsize(_bsize),
xsize(_xsize),
ovrlp(_ovrlp),
incr(0),
iasize(0),
iainidx(0),
iaoutidx(0),
xaux(nullptr),
nsamps(0),
oasize(0),
oainidx(0),
oaoutidx(0),
init_oaoutidx(0),
resamprun(0),
isize(0),
inresamp(nullptr),
outresamp(nullptr),
out_low_cut(_out_low_cut),
2024-08-03 05:05:12 -04:00
out_high_cut(_out_high_cut),
exec(_xsize, _asize, _npasses),
sdet(_xsize, _k1, _k2, _b, _pre, _post),
wrk(_xsize, _asize)
{
scan.pmultmin = _pmultmin;
calc();
2024-08-03 05:05:12 -04:00
xbase.resize(2 * xsize);
xaux = &xbase[xsize];
2024-06-16 05:31:13 -04:00
}
void SNBA::decalc()
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
delete outresamp;
delete inresamp;
2024-06-16 05:31:13 -04:00
}
SNBA::~SNBA()
2024-06-16 05:31:13 -04:00
{
decalc();
2024-06-16 05:31:13 -04:00
}
void SNBA::flush()
2024-06-16 05:31:13 -04:00
{
iainidx = 0;
iaoutidx = 0;
nsamps = 0;
oainidx = 0;
oaoutidx = init_oaoutidx;
2024-08-03 05:05:12 -04:00
exec.fluxh();
sdet.flush();
std::fill(inaccum.begin(), inaccum.end(), 0);
std::fill(outaccum.begin(), outaccum.end(), 0);
std::fill(xaux, xaux + xsize, 0);
2024-08-10 17:46:47 -04:00
std::fill(inbuff.begin(), inbuff.end(), 0);
std::fill(outbuff.begin(), outbuff.end(), 0);
inresamp->flush();
outresamp->flush();
2024-06-16 05:31:13 -04:00
}
void SNBA::setBuffers(float* _in, float* _out)
2024-06-16 05:31:13 -04:00
{
decalc();
in = _in;
out = _out;
calc();
2024-06-16 05:31:13 -04:00
}
void SNBA::setSamplerate(int rate)
2024-06-16 05:31:13 -04:00
{
decalc();
inrate = rate;
calc();
2024-06-16 05:31:13 -04:00
}
void SNBA::setSize(int size)
2024-06-16 05:31:13 -04:00
{
decalc();
bsize = size;
calc();
2024-06-16 05:31:13 -04:00
}
2024-08-03 05:05:12 -04:00
void SNBA::ATAc0 (int n, int nr, std::vector<double>& A, std::vector<double>& r)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
std::fill(r.begin(), r.begin() + n, 0);
2024-08-03 05:05:12 -04:00
for (int i = 0; i < n; i++)
{
2024-08-03 05:05:12 -04:00
for (int j = 0; j < nr; j++)
2024-06-16 05:31:13 -04:00
r[i] += A[j * n + i] * A[j * n + 0];
}
2024-06-16 05:31:13 -04:00
}
2024-08-03 05:05:12 -04:00
void SNBA::multA1TA2(std::vector<double>& a1, std::vector<double>& a2, int m, int n, int q, std::vector<double>& c)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
int k;
2024-06-16 05:31:13 -04:00
int p = q - m;
2024-08-03 05:05:12 -04:00
std::fill(c.begin(), c.begin() + m*n, 0);
2024-07-02 18:52:16 -04:00
2024-08-03 05:05:12 -04:00
for (int i = 0; i < m; i++)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
for (int j = 0; j < n; j++)
2024-06-16 05:31:13 -04:00
{
if (j < p)
{
for (k = i; k <= std::min(i + p, j); k++)
c[i * n + j] += a1[k * m + i] * a2[k * n + j];
}
if (j >= n - p)
{
for (k = std::max(i, q - (n - j)); k <= i + p; k++)
c[i * n + j] += a1[k * m + i] * a2[k * n + j];
}
}
}
}
2024-08-03 05:05:12 -04:00
void SNBA::multXKE(std::vector<double>& a, const double* xk, int m, int q, int p, std::vector<double>& vout)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
int k;
std::fill(vout.begin(), vout.begin() + m, 0);
2024-07-02 18:52:16 -04:00
2024-08-03 05:05:12 -04:00
for (int i = 0; i < m; i++)
2024-06-16 05:31:13 -04:00
{
for (k = i; k < p; k++)
vout[i] += a[i * q + k] * xk[k];
for (k = q - p; k <= q - m + i; k++)
vout[i] += a[i * q + k] * xk[k];
}
}
2024-08-03 05:05:12 -04:00
void SNBA::multAv(std::vector<double>& a, std::vector<double>& v, int m, int q, std::vector<double>& vout)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
std::fill(vout.begin(), vout.begin() + m, 0);
2024-07-02 18:52:16 -04:00
2024-08-03 05:05:12 -04:00
for (int i = 0; i < m; i++)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
for (int k = 0; k < q; k++)
2024-06-16 05:31:13 -04:00
vout[i] += a[i * q + k] * v[k];
}
}
void SNBA::xHat(
int xusize,
int asize,
2024-08-03 05:05:12 -04:00
const double* xk,
std::vector<double>& a,
std::vector<double>& xout,
std::vector<double>& r,
std::vector<double>& ATAI,
std::vector<double>& A1,
std::vector<double>& A2,
std::vector<double>& P1,
std::vector<double>& P2,
std::vector<double>& trI_y,
std::vector<double>& trI_v,
std::vector<double>& dR_z
2024-06-16 05:31:13 -04:00
)
{
2024-08-03 05:05:12 -04:00
int i;
int j;
int k;
2024-06-16 05:31:13 -04:00
int a1rows = xusize + asize;
int a2cols = xusize + 2 * asize;
2024-08-03 05:05:12 -04:00
std::fill (r.begin(), r.begin() + xusize, 0); // work space
std::fill (ATAI.begin(), ATAI.begin() + xusize * xusize, 0); // work space
std::fill (A1.begin(), A1.begin() + a1rows * xusize, 0); // work space
std::fill (A2.begin(), A2.begin() + a1rows * a2cols, 0); // work space
std::fill (P1.begin(), P1.begin() + xusize * a2cols, 0); // work space
std::fill (P2.begin(), P2.begin() + xusize, 0); // work space
2024-06-16 05:31:13 -04:00
for (i = 0; i < xusize; i++)
{
A1[i * xusize + i] = 1.0;
k = i + 1;
for (j = k; j < k + asize; j++)
A1[j * xusize + i] = - a[j - k];
}
for (i = 0; i < asize; i++)
2024-08-03 05:05:12 -04:00
{
for (k = asize - i - 1, j = 0; k < asize; k++, j++)
A2[j * a2cols + i] = a[k];
}
2024-06-16 05:31:13 -04:00
for (i = asize + xusize; i < 2 * asize + xusize; i++)
2024-08-03 05:05:12 -04:00
{
A2[(i - asize) * a2cols + i] = - 1.0;
for (j = i - asize + 1, k = 0; j < xusize + asize; j++, k++)
A2[j * a2cols + i] = a[k];
}
2024-06-16 05:31:13 -04:00
ATAc0(xusize, xusize + asize, A1, r);
2024-08-03 05:05:12 -04:00
LMathd::trI(xusize, r.data(), ATAI.data(), trI_y.data(), trI_v.data(), dR_z.data());
2024-06-16 05:31:13 -04:00
multA1TA2(A1, A2, xusize, 2 * asize + xusize, xusize + asize, P1);
multXKE(P1, xk, xusize, xusize + 2 * asize, asize, P2);
multAv(ATAI, P2, xusize, xusize, xout);
}
2024-08-03 05:05:12 -04:00
void SNBA::invf(int xsize, int asize, std::vector<double>& a, const double* x, std::vector<double>& v)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
int i;
int j;
std::fill(v.begin(), v.begin() + xsize, 0);
2024-07-02 18:52:16 -04:00
2024-06-16 05:31:13 -04:00
for (i = asize; i < xsize - asize; i++)
{
for (j = 0; j < asize; j++)
v[i] += a[j] * (x[i - 1 - j] + x[i + 1 + j]);
v[i] = x[i] - 0.5 * v[i];
}
for (i = xsize - asize; i < xsize; i++)
{
for (j = 0; j < asize; j++)
v[i] += a[j] * x[i - 1 - j];
v[i] = x[i] - v[i];
}
}
2024-08-03 05:05:12 -04:00
void SNBA::det(int asize, std::vector<double>& v, std::vector<int>& detout)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
int i;
int j;
2024-07-02 19:03:49 -04:00
double medpwr;
2024-08-03 05:05:12 -04:00
double t1;
double t2;
int bstate;
int bcount;
int bsamp;
2024-07-02 18:52:16 -04:00
for (i = asize, j = 0; i < xsize; i++, j++)
2024-06-16 05:31:13 -04:00
{
sdet.vpwr[i] = v[i] * v[i];
sdet.vp[j] = sdet.vpwr[i];
2024-06-16 05:31:13 -04:00
}
2024-07-02 18:52:16 -04:00
2024-08-03 05:05:12 -04:00
LMathd::median(xsize - asize, sdet.vp.data(), &medpwr);
t1 = sdet.k1 * medpwr;
2024-06-16 05:31:13 -04:00
t2 = 0.0;
2024-07-02 18:52:16 -04:00
for (i = asize; i < xsize; i++)
2024-06-16 05:31:13 -04:00
{
if (sdet.vpwr[i] <= t1)
t2 += sdet.vpwr[i];
else if (sdet.vpwr[i] <= 2.0 * t1)
t2 += 2.0 * t1 - sdet.vpwr[i];
2024-06-16 05:31:13 -04:00
}
t2 *= sdet.k2 / (double) (xsize - asize);
2024-07-02 18:52:16 -04:00
for (i = asize; i < xsize; i++)
2024-06-16 05:31:13 -04:00
{
if (sdet.vpwr[i] > t2)
2024-06-16 05:31:13 -04:00
detout[i] = 1;
else
detout[i] = 0;
}
2024-07-02 18:52:16 -04:00
2024-06-16 05:31:13 -04:00
bstate = 0;
bcount = 0;
bsamp = 0;
2024-07-02 18:52:16 -04:00
for (i = asize; i < xsize; i++)
2024-06-16 05:31:13 -04:00
{
switch (bstate)
{
case 0:
if (detout[i] == 1)
bstate = 1;
2024-06-16 05:31:13 -04:00
break;
2024-06-16 05:31:13 -04:00
case 1:
if (detout[i] == 0)
{
bstate = 2;
bsamp = i;
bcount = 1;
}
2024-06-16 05:31:13 -04:00
break;
2024-06-16 05:31:13 -04:00
case 2:
++bcount;
if (bcount > sdet.b)
{
2024-06-16 05:31:13 -04:00
if (detout[i] == 1)
bstate = 1;
else
bstate = 0;
}
2024-06-16 05:31:13 -04:00
else if (detout[i] == 1)
{
for (j = bsamp; j < bsamp + bcount - 1; j++)
detout[j] = 1;
bstate = 1;
}
2024-08-03 05:05:12 -04:00
break;
default:
2024-06-16 05:31:13 -04:00
break;
}
}
for (i = asize; i < xsize; i++)
2024-06-16 05:31:13 -04:00
{
if (detout[i] == 1)
{
for (j = i - 1; j > i - 1 - sdet.pre; j--)
{
if (j >= asize)
detout[j] = 1;
}
2024-06-16 05:31:13 -04:00
}
}
for (i = xsize - 1; i >= asize; i--)
2024-06-16 05:31:13 -04:00
{
if (detout[i] == 1)
{
for (j = i + 1; j < i + 1 + sdet.post; j++)
{
if (j < xsize)
detout[j] = 1;
}
2024-06-16 05:31:13 -04:00
}
}
}
int SNBA::scanFrame(
int xsize,
int pval,
2024-07-02 18:52:16 -04:00
double pmultmin,
2024-08-03 05:05:12 -04:00
std::vector<int>& det,
std::array<int, MAXIMP>& bimp,
std::array<int, MAXIMP>& limp,
std::array<int, MAXIMP>& befimp,
std::array<int, MAXIMP>& aftimp,
std::array<int, MAXIMP>& p_opt,
2024-06-16 05:31:13 -04:00
int* next
)
{
int inflag = 0;
2024-08-03 05:05:12 -04:00
int i = 0;
int j = 0;
int k = 0;
2024-06-16 05:31:13 -04:00
int nimp = 0;
2024-07-02 18:52:16 -04:00
double td;
2024-06-16 05:31:13 -04:00
int ti;
2024-08-03 05:05:12 -04:00
std::array<double, MAXIMP> merit = { 0 };
std::array<int, MAXIMP> nextlist;
std::fill(befimp.begin(), befimp.end(), 0);
std::fill(aftimp.begin(), aftimp.end(), 0);
2024-06-16 05:31:13 -04:00
while (i < xsize && nimp < MAXIMP)
{
if (det[i] == 1 && inflag == 0)
{
inflag = 1;
bimp[nimp] = i;
limp[nimp] = 1;
nimp++;
}
else if (det[i] == 1)
{
2024-08-03 05:05:12 -04:00
if (nimp > 0)
limp[nimp - 1]++;
2024-06-16 05:31:13 -04:00
}
else
{
inflag = 0;
befimp[nimp]++;
if (nimp > 0)
aftimp[nimp - 1]++;
}
2024-06-16 05:31:13 -04:00
i++;
}
2024-06-16 05:31:13 -04:00
for (i = 0; i < nimp; i++)
{
if (befimp[i] < aftimp[i])
p_opt[i] = befimp[i];
else
p_opt[i] = aftimp[i];
2024-06-16 05:31:13 -04:00
if (p_opt[i] > pval)
p_opt[i] = pval;
2024-06-16 05:31:13 -04:00
if (p_opt[i] < (int)(pmultmin * limp[i]))
p_opt[i] = -1;
}
for (i = 0; i < nimp; i++)
{
2024-07-02 18:52:16 -04:00
merit[i] = (double)p_opt[i] / (double)limp[i];
2024-06-16 05:31:13 -04:00
nextlist[i] = i;
}
2024-06-16 05:31:13 -04:00
for (j = 0; j < nimp - 1; j++)
{
for (k = 0; k < nimp - j - 1; k++)
{
if (merit[k] < merit[k + 1])
{
td = merit[k];
ti = nextlist[k];
merit[k] = merit[k + 1];
nextlist[k] = nextlist[k + 1];
merit[k + 1] = td;
nextlist[k + 1] = ti;
}
}
}
2024-06-16 05:31:13 -04:00
i = 1;
2024-06-16 05:31:13 -04:00
if (nimp > 0)
{
while (merit[i] == merit[0] && i < nimp)
i++;
}
2024-06-16 05:31:13 -04:00
for (j = 0; j < i - 1; j++)
{
for (k = 0; k < i - j - 1; k++)
{
if (limp[nextlist[k]] < limp[nextlist[k + 1]])
{
td = merit[k];
ti = nextlist[k];
merit[k] = merit[k + 1];
nextlist[k] = nextlist[k + 1];
merit[k + 1] = td;
nextlist[k + 1] = ti;
}
}
}
2024-06-16 05:31:13 -04:00
*next = nextlist[0];
return nimp;
}
void SNBA::execFrame(double* x)
2024-06-16 05:31:13 -04:00
{
int nimp;
2024-08-03 05:05:12 -04:00
std::array<int, MAXIMP> bimp;
std::array<int, MAXIMP> limp;
std::array<int, MAXIMP> befimp;
std::array<int, MAXIMP> aftimp;
std::array<int, MAXIMP> p_opt;
2024-06-16 05:31:13 -04:00
int next = 0;
int p;
2024-08-03 05:05:12 -04:00
std::copy(x, x + xsize, exec.savex.begin());
LMathd::asolve(xsize, exec.asize, x, exec.a.data(), wrk.asolve_r.data(), wrk.asolve_z.data());
invf(xsize, exec.asize, exec.a, x, exec.v);
det(exec.asize, exec.v, exec.detout);
2024-07-02 18:52:16 -04:00
2024-08-03 05:05:12 -04:00
for (int i = 0; i < xsize; i++)
2024-06-16 05:31:13 -04:00
{
if (exec.detout[i] != 0)
2024-06-16 05:31:13 -04:00
x[i] = 0.0;
}
2024-07-02 18:52:16 -04:00
nimp = scanFrame(xsize, exec.asize, scan.pmultmin, exec.detout, bimp, limp, befimp, aftimp, p_opt, &next);
2024-07-02 18:52:16 -04:00
2024-08-03 05:05:12 -04:00
for (int pass = 0; pass < exec.npasses; pass++)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
std::copy(exec.detout.begin(), exec.detout.end(), exec.unfixed.begin());
2024-07-02 18:52:16 -04:00
2024-08-03 05:05:12 -04:00
for (int k = 0; k < nimp; k++)
2024-06-16 05:31:13 -04:00
{
if (k > 0)
scanFrame(xsize, exec.asize, scan.pmultmin, exec.unfixed, bimp, limp, befimp, aftimp, p_opt, &next);
2024-06-16 05:31:13 -04:00
if ((p = p_opt[next]) > 0)
{
2024-08-03 05:05:12 -04:00
LMathd::asolve(xsize, p, x, exec.a.data(), wrk.asolve_r.data(), wrk.asolve_z.data());
xHat(
limp[next],
p,
&x[bimp[next] - p],
exec.a,
exec.xHout,
wrk.xHat_r,
wrk.xHat_ATAI,
wrk.xHat_A1,
wrk.xHat_A2,
wrk.xHat_P1,
wrk.xHat_P2,
wrk.trI_y,
wrk.trI_v,
wrk.dR_z
);
2024-08-03 05:05:12 -04:00
std::copy(exec.xHout.begin(), exec.xHout.begin() + limp[next], &x[bimp[next]]);
memset (&exec.unfixed[bimp[next]], 0, limp[next] * sizeof (int));
2024-06-16 05:31:13 -04:00
}
else
{
memcpy (&x[bimp[next]], &exec.savex[bimp[next]], limp[next] * sizeof (double));
2024-06-16 05:31:13 -04:00
}
}
}
}
void SNBA::execute()
2024-06-16 05:31:13 -04:00
{
if (run)
2024-06-16 05:31:13 -04:00
{
int i;
inresamp->execute();
2024-07-02 18:52:16 -04:00
for (i = 0; i < 2 * isize; i += 2)
2024-06-16 05:31:13 -04:00
{
inaccum[iainidx] = inbuff[i];
iainidx = (iainidx + 1) % iasize;
2024-06-16 05:31:13 -04:00
}
2024-07-02 18:52:16 -04:00
nsamps += isize;
2024-07-02 18:52:16 -04:00
while (nsamps >= incr)
2024-06-16 05:31:13 -04:00
{
memcpy (&xaux[xsize - incr], &inaccum[iaoutidx], incr * sizeof (double));
execFrame (xaux);
iaoutidx = (iaoutidx + incr) % iasize;
nsamps -= incr;
memcpy (&outaccum[oainidx], xaux, incr * sizeof (double));
oainidx = (oainidx + incr) % oasize;
2024-08-03 05:05:12 -04:00
std::copy(&xbase[incr], &xbase[incr] + (2 * xsize - incr), xbase.begin());
2024-06-16 05:31:13 -04:00
}
2024-07-02 18:52:16 -04:00
for (i = 0; i < isize; i++)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
outbuff[2 * i + 0] = (float) outaccum[oaoutidx];
outbuff[2 * i + 1] = 0.0;
oaoutidx = (oaoutidx + 1) % oasize;
2024-06-16 05:31:13 -04:00
}
2024-07-02 18:52:16 -04:00
outresamp->execute();
2024-06-16 05:31:13 -04:00
}
else if (out != in)
{
std::copy(in, in + bsize * 2, out);
}
2024-06-16 05:31:13 -04:00
}
/********************************************************************************************************
* *
* Public Properties *
2024-06-16 05:31:13 -04:00
* *
********************************************************************************************************/
void SNBA::setOvrlp(int _ovrlp)
2024-06-16 05:31:13 -04:00
{
decalc();
ovrlp = _ovrlp;
calc();
2024-06-16 05:31:13 -04:00
}
void SNBA::setAsize(int size)
2024-06-16 05:31:13 -04:00
{
exec.asize = size;
2024-06-16 05:31:13 -04:00
}
void SNBA::setNpasses(int npasses)
2024-06-16 05:31:13 -04:00
{
exec.npasses = npasses;
2024-06-16 05:31:13 -04:00
}
void SNBA::setK1(double k1)
2024-06-16 05:31:13 -04:00
{
sdet.k1 = k1;
2024-06-16 05:31:13 -04:00
}
void SNBA::setK2(double k2)
2024-06-16 05:31:13 -04:00
{
sdet.k2 = k2;
2024-06-16 05:31:13 -04:00
}
void SNBA::setBridge(int bridge)
2024-06-16 05:31:13 -04:00
{
sdet.b = bridge;
2024-06-16 05:31:13 -04:00
}
void SNBA::setPresamps(int presamps)
2024-06-16 05:31:13 -04:00
{
sdet.pre = presamps;
2024-06-16 05:31:13 -04:00
}
void SNBA::setPostsamps(int postsamps)
2024-06-16 05:31:13 -04:00
{
sdet.post = postsamps;
2024-06-16 05:31:13 -04:00
}
void SNBA::setPmultmin(double pmultmin)
2024-06-16 05:31:13 -04:00
{
scan.pmultmin = pmultmin;
2024-06-16 05:31:13 -04:00
}
void SNBA::setOutputBandwidth(double flow, double fhigh)
2024-06-16 05:31:13 -04:00
{
2024-08-03 05:05:12 -04:00
double f_low = 0;
double f_high = 0;
2024-06-16 05:31:13 -04:00
if (flow >= 0 && fhigh >= 0)
{
if (fhigh < out_low_cut)
fhigh = out_low_cut;
2024-07-13 17:59:46 -04:00
if (flow > out_high_cut)
flow = out_high_cut;
2024-07-13 17:59:46 -04:00
2024-08-03 05:05:12 -04:00
f_low = std::max (out_low_cut, flow);
f_high = std::min (out_high_cut, fhigh);
2024-06-16 05:31:13 -04:00
}
else if (flow <= 0 && fhigh <= 0)
{
if (flow > -out_low_cut)
flow = -out_low_cut;
2024-07-13 17:59:46 -04:00
if (fhigh < -out_high_cut)
fhigh = -out_high_cut;
2024-07-13 17:59:46 -04:00
2024-08-03 05:05:12 -04:00
f_low = std::max (out_low_cut, -fhigh);
f_high = std::min (out_high_cut, -flow);
2024-06-16 05:31:13 -04:00
}
else if (flow < 0 && fhigh > 0)
{
2024-07-02 18:52:16 -04:00
double absmax = std::max (-flow, fhigh);
2024-07-13 17:59:46 -04:00
if (absmax < out_low_cut)
absmax = out_low_cut;
2024-07-13 17:59:46 -04:00
f_low = out_low_cut;
f_high = std::min (out_high_cut, absmax);
2024-06-16 05:31:13 -04:00
}
outresamp->setBandwidth(f_low, f_high);
2024-06-16 05:31:13 -04:00
}
2024-07-02 18:52:16 -04:00
} // namespace