1
0
mirror of https://github.com/gnss-sdr/gnss-sdr synced 2024-10-01 16:30:50 +00:00

Merge branch 'next' of https://github.com/gnss-sdr/gnss-sdr into next

This commit is contained in:
Carles Fernandez 2018-12-03 11:31:16 +01:00
commit 42d4c39995
No known key found for this signature in database
GPG Key ID: 4C583C52B0C3877D
118 changed files with 352 additions and 450 deletions

View File

@ -547,7 +547,7 @@ private:
*/
inline double asDouble(const std::string& s)
{
return strtod(s.c_str(), 0);
return strtod(s.c_str(), nullptr);
}
@ -560,7 +560,7 @@ private:
*/
inline int64_t asInt(const std::string& s)
{
return strtol(s.c_str(), 0, 10);
return strtol(s.c_str(), nullptr, 10);
}
@ -796,7 +796,7 @@ inline std::string Rinex_Printer::asFixWidthString(const int x, const int width,
inline int64_t asInt(const std::string& s)
{
return strtol(s.c_str(), 0, 10);
return strtol(s.c_str(), nullptr, 10);
}

View File

@ -245,8 +245,8 @@ bool rtklib_solver::save_matfile()
std::string filename = dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("TOW_at_current_symbol_ms", MAT_C_UINT32, MAT_T_UINT32, 2, dims, TOW_at_current_symbol_ms, 0);

View File

@ -117,8 +117,8 @@ galileo_e5a_noncoherentIQ_acquisition_caf_cc::galileo_e5a_noncoherentIQ_acquisit
}
else
{
d_fft_code_Q_A = 0;
d_magnitudeQA = 0;
d_fft_code_Q_A = nullptr;
d_magnitudeQA = nullptr;
}
// IF COHERENT INTEGRATION TIME > 1
if (d_sampled_ms > 1)
@ -132,16 +132,16 @@ galileo_e5a_noncoherentIQ_acquisition_caf_cc::galileo_e5a_noncoherentIQ_acquisit
}
else
{
d_fft_code_Q_B = 0;
d_magnitudeQB = 0;
d_fft_code_Q_B = nullptr;
d_magnitudeQB = nullptr;
}
}
else
{
d_fft_code_I_B = 0;
d_magnitudeIB = 0;
d_fft_code_Q_B = 0;
d_magnitudeQB = 0;
d_fft_code_I_B = nullptr;
d_magnitudeIB = nullptr;
d_fft_code_Q_B = nullptr;
d_magnitudeQB = nullptr;
}
// Direct FFT
@ -157,14 +157,14 @@ galileo_e5a_noncoherentIQ_acquisition_caf_cc::galileo_e5a_noncoherentIQ_acquisit
d_doppler_resolution = 0;
d_threshold = 0;
d_doppler_step = 250;
d_grid_doppler_wipeoffs = 0;
d_gnss_synchro = 0;
d_grid_doppler_wipeoffs = nullptr;
d_gnss_synchro = nullptr;
d_code_phase = 0;
d_doppler_freq = 0;
d_test_statistics = 0;
d_CAF_vector = 0;
d_CAF_vector_I = 0;
d_CAF_vector_Q = 0;
d_CAF_vector = nullptr;
d_CAF_vector_I = nullptr;
d_CAF_vector_Q = nullptr;
d_channel = 0;
d_gr_stream_buffer = 0;
}

View File

@ -92,8 +92,8 @@ galileo_pcps_8ms_acquisition_cc::galileo_pcps_8ms_acquisition_cc(
d_doppler_resolution = 0;
d_threshold = 0;
d_doppler_step = 0;
d_grid_doppler_wipeoffs = 0;
d_gnss_synchro = 0;
d_grid_doppler_wipeoffs = nullptr;
d_gnss_synchro = nullptr;
d_code_phase = 0;
d_doppler_freq = 0;
d_test_statistics = 0;

View File

@ -34,8 +34,8 @@
*/
#include "pcps_acquisition.h"
#include "GLONASS_L1_L2_CA.h" // for GLONASS_TWO_PI
#include "GPS_L1_CA.h" // for GPS_TWO_PI
#include "GLONASS_L1_L2_CA.h" // for GLONASS_TWO_PI"
#include "gnss_sdr_create_directory.h"
#include <boost/filesystem/path.hpp>
#include <glog/logging.h>
@ -120,7 +120,7 @@ pcps_acquisition::pcps_acquisition(const Acq_Conf& conf_) : gr::block("pcps_acqu
// Inverse FFT
d_ifft = new gr::fft::fft_complex(d_fft_size, false);
d_gnss_synchro = 0;
d_gnss_synchro = nullptr;
d_grid_doppler_wipeoffs = nullptr;
d_grid_doppler_wipeoffs_step_two = nullptr;
d_magnitude_grid = nullptr;
@ -445,8 +445,8 @@ void pcps_acquisition::dump_results(int32_t effective_fft_size)
filename.append(std::to_string(d_gnss_synchro->PRN));
filename.append(".mat");
mat_t* matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (matfp == NULL)
mat_t* matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (matfp == nullptr)
{
std::cout << "Unable to create or open Acquisition dump file" << std::endl;
//acq_parameters.dump = false;

View File

@ -123,9 +123,9 @@ pcps_acquisition_fine_doppler_cc::pcps_acquisition_fine_doppler_cc(const Acq_Con
d_threshold = 0;
d_num_doppler_points = 0;
d_doppler_step = 0;
d_grid_data = 0;
d_grid_doppler_wipeoffs = 0;
d_gnss_synchro = 0;
d_grid_data = nullptr;
d_grid_doppler_wipeoffs = nullptr;
d_gnss_synchro = nullptr;
d_code_phase = 0;
d_doppler_freq = 0;
d_test_statistics = 0;
@ -672,8 +672,8 @@ void pcps_acquisition_fine_doppler_cc::dump_results(int effective_fft_size)
filename.append(std::to_string(d_gnss_synchro->PRN));
filename.append(".mat");
mat_t *matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (matfp == NULL)
mat_t *matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (matfp == nullptr)
{
std::cout << "Unable to create or open Acquisition dump file" << std::endl;
d_dump = false;

View File

@ -97,9 +97,9 @@ pcps_assisted_acquisition_cc::pcps_assisted_acquisition_cc(
d_doppler_min = 0;
d_num_doppler_points = 0;
d_doppler_step = 0;
d_grid_data = 0;
d_grid_doppler_wipeoffs = 0;
d_gnss_synchro = 0;
d_grid_data = nullptr;
d_grid_doppler_wipeoffs = nullptr;
d_gnss_synchro = nullptr;
d_code_phase = 0;
d_doppler_freq = 0;
d_test_statistics = 0;

View File

@ -103,8 +103,8 @@ pcps_cccwsr_acquisition_cc::pcps_cccwsr_acquisition_cc(
d_doppler_resolution = 0;
d_threshold = 0;
d_doppler_step = 0;
d_grid_doppler_wipeoffs = 0;
d_gnss_synchro = 0;
d_grid_doppler_wipeoffs = nullptr;
d_gnss_synchro = nullptr;
d_code_phase = 0;
d_doppler_freq = 0;
d_test_statistics = 0;

View File

@ -112,16 +112,16 @@ pcps_quicksync_acquisition_cc::pcps_quicksync_acquisition_cc(
d_dump = dump;
d_dump_filename = dump_filename;
d_corr_acumulator = 0;
d_signal_folded = 0;
d_corr_acumulator = nullptr;
d_signal_folded = nullptr;
d_code_folded = new gr_complex[d_fft_size]();
d_noise_floor_power = 0;
d_doppler_resolution = 0;
d_threshold = 0;
d_doppler_step = 0;
d_grid_doppler_wipeoffs = 0;
d_fft_if2 = 0;
d_gnss_synchro = 0;
d_grid_doppler_wipeoffs = nullptr;
d_fft_if2 = nullptr;
d_gnss_synchro = nullptr;
d_code_phase = 0;
d_doppler_freq = 0;
d_test_statistics = 0;

View File

@ -116,9 +116,9 @@ pcps_tong_acquisition_cc::pcps_tong_acquisition_cc(
d_doppler_resolution = 0;
d_threshold = 0;
d_doppler_step = 0;
d_grid_data = 0;
d_grid_doppler_wipeoffs = 0;
d_gnss_synchro = 0;
d_grid_data = nullptr;
d_grid_doppler_wipeoffs = nullptr;
d_gnss_synchro = nullptr;
d_code_phase = 0;
d_doppler_freq = 0;
d_test_statistics = 0;

View File

@ -55,7 +55,7 @@ ArraySignalConditioner::ArraySignalConditioner(ConfigurationInterface *configura
// Destructor
ArraySignalConditioner::~ArraySignalConditioner() {}
ArraySignalConditioner::~ArraySignalConditioner() = default;
void ArraySignalConditioner::connect(gr::top_block_sptr top_block)

View File

@ -55,7 +55,7 @@ SignalConditioner::SignalConditioner(ConfigurationInterface *configuration,
// Destructor
SignalConditioner::~SignalConditioner() {}
SignalConditioner::~SignalConditioner() = default;
void SignalConditioner::connect(gr::top_block_sptr top_block)

View File

@ -71,9 +71,7 @@ ByteToShort::ByteToShort(ConfigurationInterface* configuration, std::string role
}
ByteToShort::~ByteToShort()
{
}
ByteToShort::~ByteToShort() = default;
void ByteToShort::connect(gr::top_block_sptr top_block)

View File

@ -77,9 +77,7 @@ IbyteToCbyte::IbyteToCbyte(ConfigurationInterface* configuration, std::string ro
}
IbyteToCbyte::~IbyteToCbyte()
{
}
IbyteToCbyte::~IbyteToCbyte() = default;
void IbyteToCbyte::connect(gr::top_block_sptr top_block)

View File

@ -75,9 +75,7 @@ IbyteToComplex::IbyteToComplex(ConfigurationInterface* configuration, std::strin
}
IbyteToComplex::~IbyteToComplex()
{
}
IbyteToComplex::~IbyteToComplex() = default;
void IbyteToComplex::connect(gr::top_block_sptr top_block)

View File

@ -78,9 +78,7 @@ IbyteToCshort::IbyteToCshort(ConfigurationInterface* configuration, std::string
}
IbyteToCshort::~IbyteToCshort()
{
}
IbyteToCshort::~IbyteToCshort() = default;
void IbyteToCshort::connect(gr::top_block_sptr top_block)

View File

@ -75,9 +75,7 @@ IshortToComplex::IshortToComplex(ConfigurationInterface* configuration, std::str
}
IshortToComplex::~IshortToComplex()
{
}
IshortToComplex::~IshortToComplex() = default;
void IshortToComplex::connect(gr::top_block_sptr top_block)

View File

@ -77,9 +77,7 @@ IshortToCshort::IshortToCshort(ConfigurationInterface* configuration, std::strin
}
IshortToCshort::~IshortToCshort()
{
}
IshortToCshort::~IshortToCshort() = default;
void IshortToCshort::connect(gr::top_block_sptr top_block)

View File

@ -79,7 +79,7 @@ BeamformerFilter::BeamformerFilter(
}
BeamformerFilter::~BeamformerFilter() {}
BeamformerFilter::~BeamformerFilter() = default;
void BeamformerFilter::connect(gr::top_block_sptr top_block)

View File

@ -142,9 +142,7 @@ FirFilter::FirFilter(ConfigurationInterface* configuration, std::string role,
}
FirFilter::~FirFilter()
{
}
FirFilter::~FirFilter() = default;
void FirFilter::connect(gr::top_block_sptr top_block)

View File

@ -196,9 +196,7 @@ FreqXlatingFirFilter::FreqXlatingFirFilter(ConfigurationInterface* configuration
}
FreqXlatingFirFilter::~FreqXlatingFirFilter()
{
}
FreqXlatingFirFilter::~FreqXlatingFirFilter() = default;
void FreqXlatingFirFilter::connect(gr::top_block_sptr top_block)

View File

@ -92,9 +92,7 @@ NotchFilter::NotchFilter(ConfigurationInterface* configuration, std::string role
}
NotchFilter::~NotchFilter()
{
}
NotchFilter::~NotchFilter() = default;
void NotchFilter::connect(gr::top_block_sptr top_block)

View File

@ -99,9 +99,7 @@ NotchFilterLite::NotchFilterLite(ConfigurationInterface* configuration, std::str
}
NotchFilterLite::~NotchFilterLite()
{
}
NotchFilterLite::~NotchFilterLite() = default;
void NotchFilterLite::connect(gr::top_block_sptr top_block)

View File

@ -105,9 +105,7 @@ PulseBlankingFilter::PulseBlankingFilter(ConfigurationInterface* configuration,
}
PulseBlankingFilter::~PulseBlankingFilter()
{
}
PulseBlankingFilter::~PulseBlankingFilter() = default;
void PulseBlankingFilter::connect(gr::top_block_sptr top_block)

View File

@ -120,9 +120,7 @@ Pass_Through::Pass_Through(ConfigurationInterface* configuration, std::string ro
}
Pass_Through::~Pass_Through()
{
}
Pass_Through::~Pass_Through() = default;
void Pass_Through::connect(gr::top_block_sptr top_block)

View File

@ -152,7 +152,7 @@ eph_t eph_to_rtklib(const Galileo_Ephemeris& gal_eph)
/* adjustment for week handover */
double tow, toc;
tow = time2gpst(rtklib_sat.ttr, &rtklib_sat.week);
toc = time2gpst(rtklib_sat.toc, NULL);
toc = time2gpst(rtklib_sat.toc, nullptr);
if (rtklib_sat.toes < tow - 302400.0)
{
rtklib_sat.week++;
@ -209,7 +209,7 @@ eph_t eph_to_rtklib(const Gps_Ephemeris& gps_eph)
/* adjustment for week handover */
double tow, toc;
tow = time2gpst(rtklib_sat.ttr, &rtklib_sat.week);
toc = time2gpst(rtklib_sat.toc, NULL);
toc = time2gpst(rtklib_sat.toc, nullptr);
if (rtklib_sat.toes < tow - 302400.0)
{
rtklib_sat.week++;
@ -274,7 +274,7 @@ eph_t eph_to_rtklib(const Gps_CNAV_Ephemeris& gps_cnav_eph)
/* adjustment for week handover */
double tow, toc;
tow = time2gpst(rtklib_sat.ttr, &rtklib_sat.week);
toc = time2gpst(rtklib_sat.toc, NULL);
toc = time2gpst(rtklib_sat.toc, nullptr);
if (rtklib_sat.toes < tow - 302400.0)
{
rtklib_sat.week++;

View File

@ -129,7 +129,7 @@ void alm2pos(gtime_t time, const alm_t *alm, double *rs, double *dts)
rs[0] = rs[1] = rs[2] = *dts = 0.0;
return;
}
mu = satsys(alm->sat, NULL) == SYS_GAL ? MU_GAL : MU_GPS;
mu = satsys(alm->sat, nullptr) == SYS_GAL ? MU_GAL : MU_GPS;
M = alm->M0 + sqrt(mu / (alm->A * alm->A * alm->A)) * tk;
for (n = 0, E = M, Ek = 0.0; fabs(E - Ek) > RTOL_KEPLER && n < MAX_ITER_KEPLER; n++)
@ -457,7 +457,7 @@ eph_t *seleph(gtime_t time, int sat, int iode, const nav_t *nav)
trace(4, "seleph : time=%s sat=%2d iode=%d\n", time_str(time, 3), sat, iode);
switch (satsys(sat, NULL))
switch (satsys(sat, nullptr))
{
case SYS_QZS:
tmax = MAXDTOE_QZS + 1.0;
@ -490,7 +490,7 @@ eph_t *seleph(gtime_t time, int sat, int iode, const nav_t *nav)
{
trace(3, "no broadcast ephemeris: %s sat=%2d iode=%3d\n", time_str(time, 0),
sat, iode);
return NULL;
return nullptr;
}
return nav->eph + j;
}
@ -520,7 +520,7 @@ geph_t *selgeph(gtime_t time, int sat, int iode, const nav_t *nav)
{
trace(3, "no glonass ephemeris : %s sat=%2d iode=%2d\n", time_str(time, 0),
sat, iode);
return NULL;
return nullptr;
}
return nav->geph + j;
}
@ -547,7 +547,7 @@ seph_t *selseph(gtime_t time, int sat, const nav_t *nav)
if (j < 0)
{
trace(3, "no sbas ephemeris : %s sat=%2d\n", time_str(time, 0), sat);
return NULL;
return nullptr;
}
return nav->seph + j;
}
@ -564,7 +564,7 @@ int ephclk(gtime_t time, gtime_t teph, int sat, const nav_t *nav,
trace(4, "ephclk : time=%s sat=%2d\n", time_str(time, 3), sat);
sys = satsys(sat, NULL);
sys = satsys(sat, nullptr);
if (sys == SYS_GPS || sys == SYS_GAL || sys == SYS_QZS || sys == SYS_BDS)
{
@ -600,7 +600,7 @@ int ephpos(gtime_t time, gtime_t teph, int sat, const nav_t *nav,
trace(4, "ephpos : time=%s sat=%2d iode=%d\n", time_str(time, 3), sat, iode);
sys = satsys(sat, NULL);
sys = satsys(sat, nullptr);
*svh = -1;
@ -738,7 +738,7 @@ int satpos_ssr(gtime_t time, gtime_t teph, int sat, const nav_t *nav,
if (!ephpos(time, teph, sat, nav, ssr->iode, rs, dts, var, svh)) return 0;
/* satellite clock for gps, galileo and qzss */
sys = satsys(sat, NULL);
sys = satsys(sat, nullptr);
if (sys == SYS_GPS || sys == SYS_GAL || sys == SYS_QZS || sys == SYS_BDS)
{
if (!(eph = seleph(teph, sat, ssr->iode, nav))) return 0;

View File

@ -98,7 +98,7 @@ tec_t *addtec(const double *lats, const double *lons, const double *hgts,
ndata[0] = nitem(lats);
ndata[1] = nitem(lons);
ndata[2] = nitem(hgts);
if (ndata[0] <= 1 || ndata[1] <= 1 || ndata[2] <= 0) return NULL;
if (ndata[0] <= 1 || ndata[1] <= 1 || ndata[2] <= 0) return nullptr;
if (nav->nt >= nav->ntmax)
{
@ -107,9 +107,9 @@ tec_t *addtec(const double *lats, const double *lons, const double *hgts,
{
trace(1, "readionex malloc error ntmax=%d\n", nav->ntmax);
free(nav->tec);
nav->tec = NULL;
nav->tec = nullptr;
nav->nt = nav->ntmax = 0;
return NULL;
return nullptr;
}
nav->tec = nav_tec;
}
@ -128,7 +128,7 @@ tec_t *addtec(const double *lats, const double *lons, const double *hgts,
if (!(p->data = (double *)malloc(sizeof(double) * n)) ||
!(p->rms = (float *)malloc(sizeof(float) * n)))
{
return NULL;
return nullptr;
}
for (i = 0; i < n; i++)
{
@ -236,7 +236,7 @@ double readionexh(FILE *fp, double *lats, double *lons, double *hgts,
int readionexb(FILE *fp, const double *lats, const double *lons,
const double *hgts, double rb, double nexp, nav_t *nav)
{
tec_t *p = NULL;
tec_t *p = nullptr;
gtime_t time = {0, 0};
double lat, lon[3], hgt, x;
int i, j, k, n, m, index, type = 0;
@ -255,17 +255,17 @@ int readionexb(FILE *fp, const double *lats, const double *lons,
else if (strstr(label, "END OF TEC MAP") == label)
{
type = 0;
p = NULL;
p = nullptr;
}
else if (strstr(label, "START OF RMS MAP") == label)
{
type = 2;
p = NULL;
p = nullptr;
}
else if (strstr(label, "END OF RMS MAP") == label)
{
type = 0;
p = NULL;
p = nullptr;
}
else if (strstr(label, "EPOCH OF CURRENT MAP") == label)
{
@ -379,7 +379,7 @@ void readtec(const char *file, nav_t *nav, int opt)
if (!opt)
{
free(nav->tec);
nav->tec = NULL;
nav->tec = nullptr;
nav->nt = nav->ntmax = 0;
}
for (i = 0; i < MAXEXFILE; i++)

View File

@ -138,7 +138,7 @@ double prange(const obsd_t *obs, const nav_t *nav, const double *azel,
double gamma_ = 0.0;
int i = 0;
int j = 1;
int sys = satsys(obs->sat, NULL);
int sys = satsys(obs->sat, nullptr);
*var = 0.0;
if (sys == SYS_NONE)
@ -416,7 +416,7 @@ int rescode(int iter, const obsd_t *obs, int n, const double *rs,
vsat[i] = 0;
azel[i * 2] = azel[1 + i * 2] = resp[i] = 0.0;
if (!(sys = satsys(obs[i].sat, NULL))) continue;
if (!(sys = satsys(obs[i].sat, nullptr))) continue;
/* reject duplicated observation data */
if (i < n - 1 && i < MAXOBS - 1 && obs[i].sat == obs[i + 1].sat)

View File

@ -187,7 +187,7 @@ void average_LC(rtk_t *rtk, const obsd_t *obs, int n, const nav_t *nav __attribu
if (azel[1 + 2 * i] < rtk->opt.elmin) continue;
if (satsys(sat, NULL) != SYS_GPS) continue;
if (satsys(sat, nullptr) != SYS_GPS) continue;
/* triple-freq carrier and code LC (m) */
LC1 = L_LC(1, -1, 0, obs[i].L) - P_LC(1, 1, 0, obs[i].P);
@ -683,7 +683,7 @@ void testeclipse(const obsd_t *obs, int n, const nav_t *nav, double *rs)
trace(3, "testeclipse:\n");
/* unit vector of sun direction (ecef) */
sunmoonpos(gpst2utc(obs[0].time), erpv, rsun, NULL, NULL);
sunmoonpos(gpst2utc(obs[0].time), erpv, rsun, nullptr, nullptr);
if (normv3(rsun, esun) == 0) trace(1, "Error computing the norm");
for (i = 0; i < n; i++)
@ -779,7 +779,7 @@ int ifmeas(const obsd_t *obs, const nav_t *nav, const double *azel,
trace(4, "ifmeas :\n");
/* L1-L2 for GPS/GLO/QZS, L1-L5 for GAL/SBS */
if (NFREQ >= 3 && (satsys(obs->sat, NULL) & (SYS_GAL | SYS_SBS))) j = 2;
if (NFREQ >= 3 && (satsys(obs->sat, nullptr) & (SYS_GAL | SYS_SBS))) j = 2;
if (NFREQ < 2 || lam[i] == 0.0 || lam[j] == 0.0) return 0;
@ -817,7 +817,7 @@ int ifmeas(const obsd_t *obs, const nav_t *nav, const double *azel,
if (opt->sateph == EPHOPT_SBAS) meas[1] -= P1_C1; /* sbas clock based C1 */
/* gps-glonass h/w bias correction for code */
if (opt->exterr.ena[3] && satsys(obs->sat, NULL) == SYS_GLO)
if (opt->exterr.ena[3] && satsys(obs->sat, nullptr) == SYS_GLO)
{
meas[1] += c1 * opt->exterr.gpsglob[0] + c2 * opt->exterr.gpsglob[1];
}
@ -913,7 +913,7 @@ int corrmeas(const obsd_t *obs, const nav_t *nav, const double *pos,
gamma = std::pow(lam[1] / lam[0], 2.0); /* f1^2/f2^2 */
P1_P2 = nav->cbias[obs->sat - 1][0];
P1_C1 = nav->cbias[obs->sat - 1][1];
if (P1_P2 == 0.0 && (satsys(obs->sat, NULL) & (SYS_GPS | SYS_GAL | SYS_QZS)))
if (P1_P2 == 0.0 && (satsys(obs->sat, nullptr) & (SYS_GPS | SYS_GAL | SYS_QZS)))
{
P1_P2 = (1.0 - gamma) * gettgd_ppp(obs->sat, nav);
}
@ -1124,7 +1124,7 @@ void udbias_ppp(rtk_t *rtk, const obsd_t *obs, int n, const nav_t *nav)
{
sat = obs[i].sat;
j = IB_PPP(sat, &rtk->opt);
if (!corrmeas(obs + i, nav, pos, rtk->ssat[sat - 1].azel, &rtk->opt, NULL, NULL,
if (!corrmeas(obs + i, nav, pos, rtk->ssat[sat - 1].azel, &rtk->opt, nullptr, nullptr,
0.0, meas, var, &brk)) continue;
if (brk)
@ -1273,7 +1273,7 @@ int res_ppp(int iter __attribute__((unused)), const obsd_t *obs, int n, const do
for (i = 0; i < n && i < MAXOBS; i++)
{
sat = obs[i].sat;
if (!(sys = satsys(sat, NULL)) || !rtk->ssat[sat - 1].vs) continue;
if (!(sys = satsys(sat, nullptr)) || !rtk->ssat[sat - 1].vs) continue;
/* geometric distance/azimuth/elevation angle */
if ((r = geodist(rs + i * 6, rr, e)) <= 0.0 ||

View File

@ -134,7 +134,7 @@ int addpeph(nav_t *nav, peph_t *peph)
{
trace(1, "readsp3b malloc error n=%d\n", nav->nemax);
free(nav->peph);
nav->peph = NULL;
nav->peph = nullptr;
nav->ne = nav->nemax = 0;
return 0;
}
@ -361,7 +361,7 @@ void readsp3(const char *file, nav_t *nav, int opt)
*-----------------------------------------------------------------------------*/
int readsap(const char *file, gtime_t time, nav_t *nav)
{
pcvs_t pcvs = {0, 0, (pcv_t *){0}};
pcvs_t pcvs = {0, 0, (pcv_t *){nullptr}};
pcv_t pcv0 = {0, {}, {}, {0, 0}, {0, 0}, {{}, {}}, {{}, {}}}, *pcv;
int i;
@ -809,7 +809,7 @@ void satantoff(gtime_t time, const double *rs, int sat, const nav_t *nav,
trace(4, "satantoff: time=%s sat=%2d\n", time_str(time, 3), sat);
/* sun position in ecef */
sunmoonpos(gpst2utc(time), erpv, rsun, NULL, &gmst);
sunmoonpos(gpst2utc(time), erpv, rsun, nullptr, &gmst);
/* unit vectors of satellite fixed coordinates */
for (i = 0; i < 3; i++) r[i] = -rs[i];
@ -820,7 +820,7 @@ void satantoff(gtime_t time, const double *rs, int sat, const nav_t *nav,
if (!normv3(r, ey)) return;
cross3(ey, ez, ex);
if (NFREQ >= 3 && (satsys(sat, NULL) & (SYS_GAL | SYS_SBS))) k = 2;
if (NFREQ >= 3 && (satsys(sat, nullptr) & (SYS_GAL | SYS_SBS))) k = 2;
if (NFREQ < 2 || lam[j] == 0.0 || lam[k] == 0.0) return;
@ -871,8 +871,8 @@ int peph2pos(gtime_t time, int sat, const nav_t *nav, int opt,
!pephclk(time, sat, nav, dtss, &varc)) return 0;
time = timeadd(time, tt);
if (!pephpos(time, sat, nav, rst, dtst, NULL, NULL) ||
!pephclk(time, sat, nav, dtst, NULL)) return 0;
if (!pephpos(time, sat, nav, rst, dtst, nullptr, nullptr) ||
!pephclk(time, sat, nav, dtst, nullptr)) return 0;
/* satellite antenna offset correction */
if (opt)

View File

@ -88,7 +88,7 @@ int init_rtcm(rtcm_t *rtcm)
rtcm->sta.pos[i] = rtcm->sta.del[i] = 0.0;
}
rtcm->sta.hgt = 0.0;
rtcm->dgps = NULL;
rtcm->dgps = nullptr;
for (i = 0; i < MAXSAT; i++)
{
rtcm->ssr[i] = ssr0;
@ -108,9 +108,9 @@ int init_rtcm(rtcm_t *rtcm)
for (i = 0; i < 100; i++) rtcm->nmsg2[i] = 0;
for (i = 0; i < 300; i++) rtcm->nmsg3[i] = 0;
rtcm->obs.data = NULL;
rtcm->nav.eph = NULL;
rtcm->nav.geph = NULL;
rtcm->obs.data = nullptr;
rtcm->nav.eph = nullptr;
rtcm->nav.geph = nullptr;
/* reallocate memory for observation and ephemris buffer */
if (!(rtcm->obs.data = (obsd_t *)malloc(sizeof(obsd_t) * MAXOBS)) ||
@ -141,13 +141,13 @@ void free_rtcm(rtcm_t *rtcm)
/* free memory for observation and ephemeris buffer */
free(rtcm->obs.data);
rtcm->obs.data = NULL;
rtcm->obs.data = nullptr;
rtcm->obs.n = 0;
free(rtcm->nav.eph);
rtcm->nav.eph = NULL;
rtcm->nav.eph = nullptr;
rtcm->nav.n = 0;
free(rtcm->nav.geph);
rtcm->nav.geph = NULL;
rtcm->nav.geph = nullptr;
rtcm->nav.ng = 0;
}

View File

@ -2643,7 +2643,7 @@ void save_msm_obs(rtcm_t *rtcm, int sys, msm_h_t *h, const double *r,
const char *sig[32];
double tt, wl;
unsigned char code[32];
char *msm_type = (char *)"", *q = NULL;
char *msm_type = (char *)"", *q = nullptr;
int i, j, k, type, prn, sat, fn, index = 0, freq[32], ind[32];
type = getbitu(rtcm->buff, 24, 12);
@ -2966,7 +2966,7 @@ int decode_msm4(rtcm_t *rtcm, int sys)
i += 6;
}
/* save obs data in msm message */
save_msm_obs(rtcm, sys, &h, r, pr, cp, NULL, NULL, cnr, lock, NULL, half);
save_msm_obs(rtcm, sys, &h, r, pr, cp, nullptr, nullptr, cnr, lock, nullptr, half);
rtcm->obsflag = !sync;
return sync ? 0 : 1;
@ -3128,7 +3128,7 @@ int decode_msm6(rtcm_t *rtcm, int sys)
i += 10;
}
/* save obs data in msm message */
save_msm_obs(rtcm, sys, &h, r, pr, cp, NULL, NULL, cnr, lock, NULL, half);
save_msm_obs(rtcm, sys, &h, r, pr, cp, nullptr, nullptr, cnr, lock, nullptr, half);
rtcm->obsflag = !sync;
return sync ? 0 : 1;

View File

@ -111,7 +111,7 @@ const char *formatstrs[32] = {/* stream format strings */
"RINEX CLK", /* 18 */
"SBAS", /* 19 */
"NMEA 0183", /* 20 */
NULL};
nullptr};
char obscodes[][3] = {
@ -150,7 +150,7 @@ char codepris[7][MAXFREQ][16] = {
};
fatalfunc_t *fatalfunc = NULL; /* fatal callback function */
fatalfunc_t *fatalfunc = nullptr; /* fatal callback function */
/* crc tables generated by util/gencrc ---------------------------------------*/
const unsigned short tbl_CRC16[] = {
@ -469,7 +469,7 @@ void satno2id(int sat, char *id)
*-----------------------------------------------------------------------------*/
int satexclude(int sat, int svh, const prcopt_t *opt)
{
int sys = satsys(sat, NULL);
int sys = satsys(sat, nullptr);
if (svh < 0)
{
@ -829,7 +829,7 @@ double *mat(int n, int m)
{
double *p;
if (n <= 0 || m <= 0) return NULL;
if (n <= 0 || m <= 0) return nullptr;
if (!(p = (double *)malloc(sizeof(double) * n * m)))
{
fatalerr("matrix memory allocation error: n=%d,m=%d\n", n, m);
@ -847,7 +847,7 @@ int *imat(int n, int m)
{
int *p;
if (n <= 0 || m <= 0) return NULL;
if (n <= 0 || m <= 0) return nullptr;
if (!(p = (int *)malloc(sizeof(int) * n * m)))
{
fatalerr("integer matrix memory allocation error: n=%d,m=%d\n", n, m);
@ -869,7 +869,7 @@ double *zeros(int n, int m)
if ((p = mat(n, m)))
for (n = n * m - 1; n >= 0; n--) p[n] = 0.0;
#else
if (n <= 0 || m <= 0) return NULL;
if (n <= 0 || m <= 0) return nullptr;
if (!(p = (double *)calloc(sizeof(double), n * m)))
{
fatalerr("matrix memory allocation error: n=%d,m=%d\n", n, m);
@ -1474,7 +1474,7 @@ gtime_t timeget(void)
struct timeval tv;
struct tm *tt;
if (!gettimeofday(&tv, NULL) && (tt = gmtime(&tv.tv_sec)))
if (!gettimeofday(&tv, nullptr) && (tt = gmtime(&tv.tv_sec)))
{
ep[0] = tt->tm_year + 1900;
ep[1] = tt->tm_mon + 1;
@ -1777,7 +1777,7 @@ unsigned int tickget(void)
}
else
{
gettimeofday(&tv, NULL);
gettimeofday(&tv, nullptr);
return tv.tv_sec * 1000u + tv.tv_usec / 1000u;
}
#else
@ -1798,7 +1798,7 @@ void sleepms(int ms)
if (ms <= 0) return;
ts.tv_sec = (time_t)(ms / 1000);
ts.tv_nsec = (long)(ms % 1000 * 1000000);
nanosleep(&ts, NULL);
nanosleep(&ts, nullptr);
}
@ -2228,7 +2228,7 @@ int decodef(char *p, int n, double *v)
int i;
for (i = 0; i < n; i++) v[i] = 0.0;
for (i = 0, p = strtok(p, " "); p && i < n; p = strtok(NULL, " "))
for (i = 0, p = strtok(p, " "); p && i < n; p = strtok(nullptr, " "))
{
v[i++] = atof(p) * 1e-3;
}
@ -2248,7 +2248,7 @@ void addpcv(const pcv_t *pcv, pcvs_t *pcvs)
{
trace(1, "addpcv: memory allocation error\n");
free(pcvs->pcv);
pcvs->pcv = NULL;
pcvs->pcv = nullptr;
pcvs->n = pcvs->nmax = 0;
return;
}
@ -2479,8 +2479,8 @@ pcv_t *searchpcv(int sat, const char *type, gtime_t time,
{
trace(1, "type array is too long");
}
for (p = strtok(buff, " "); p && n < 2; p = strtok(NULL, " ")) types[n++] = p;
if (n <= 0) return NULL;
for (p = strtok(buff, " "); p && n < 2; p = strtok(nullptr, " ")) types[n++] = p;
if (n <= 0) return nullptr;
/* search receiver antenna with radome at first */
for (i = 0; i < pcvs->n; i++)
@ -2500,7 +2500,7 @@ pcv_t *searchpcv(int sat, const char *type, gtime_t time,
return pcv;
}
}
return NULL;
return nullptr;
}
@ -2648,7 +2648,7 @@ int readerp(const char *file, erp_t *erp)
if (!erp_data)
{
free(erp->data);
erp->data = NULL;
erp->data = nullptr;
erp->n = erp->nmax = 0;
fclose(fp);
return 0;
@ -2762,7 +2762,7 @@ void uniqeph(nav_t *nav)
{
trace(1, "uniqeph malloc error n=%d\n", nav->n);
free(nav->eph);
nav->eph = NULL;
nav->eph = nullptr;
nav->n = nav->nmax = 0;
return;
}
@ -2808,7 +2808,7 @@ void uniqgeph(nav_t *nav)
{
trace(1, "uniqgeph malloc error ng=%d\n", nav->ng);
free(nav->geph);
nav->geph = NULL;
nav->geph = nullptr;
nav->ng = nav->ngmax = 0;
return;
}
@ -2853,7 +2853,7 @@ void uniqseph(nav_t *nav)
{
trace(1, "uniqseph malloc error ns=%d\n", nav->ns);
free(nav->seph);
nav->seph = NULL;
nav->seph = nullptr;
nav->ns = nav->nsmax = 0;
return;
}
@ -2948,7 +2948,7 @@ int sortobs(obs_t *obs)
*-----------------------------------------------------------------------------*/
int screent(gtime_t time, gtime_t ts, gtime_t te, double tint)
{
return (tint <= 0.0 || fmod(time2gpst(time, NULL) + DTTOL, tint) <= DTTOL * 2.0) &&
return (tint <= 0.0 || fmod(time2gpst(time, nullptr) + DTTOL, tint) <= DTTOL * 2.0) &&
(ts.time == 0 || timediff(time, ts) >= -DTTOL) &&
(te.time == 0 || timediff(time, te) < DTTOL);
}
@ -3104,7 +3104,7 @@ int savenav(const char *file, const nav_t *nav)
void freeobs(obs_t *obs)
{
free(obs->data);
obs->data = NULL;
obs->data = nullptr;
obs->n = obs->nmax = 0;
}
@ -3124,49 +3124,49 @@ void freenav(nav_t *nav, int opt)
if (opt & 0x01)
{
free(nav->eph);
nav->eph = NULL;
nav->eph = nullptr;
nav->n = nav->nmax = 0;
}
if (opt & 0x02)
{
free(nav->geph);
nav->geph = NULL;
nav->geph = nullptr;
nav->ng = nav->ngmax = 0;
}
if (opt & 0x04)
{
free(nav->seph);
nav->seph = NULL;
nav->seph = nullptr;
nav->ns = nav->nsmax = 0;
}
if (opt & 0x08)
{
free(nav->peph);
nav->peph = NULL;
nav->peph = nullptr;
nav->ne = nav->nemax = 0;
}
if (opt & 0x10)
{
free(nav->pclk);
nav->pclk = NULL;
nav->pclk = nullptr;
nav->nc = nav->ncmax = 0;
}
if (opt & 0x20)
{
free(nav->alm);
nav->alm = NULL;
nav->alm = nullptr;
nav->na = nav->namax = 0;
}
if (opt & 0x40)
{
free(nav->tec);
nav->tec = NULL;
nav->tec = nullptr;
nav->nt = nav->ntmax = 0;
}
if (opt & 0x80)
{
free(nav->fcb);
nav->fcb = NULL;
nav->fcb = nullptr;
nav->nf = nav->nfmax = 0;
}
}
@ -3175,7 +3175,7 @@ void freenav(nav_t *nav, int opt)
/* debug trace functions -----------------------------------------------------*/
//#ifdef TRACE
//
FILE *fp_trace = NULL; /* file pointer of trace */
FILE *fp_trace = nullptr; /* file pointer of trace */
char file_trace[1024]; /* trace file */
static int level_trace = 0; /* level of trace */
unsigned int tick_trace = 0; /* tick time at traceopen (ms) */
@ -3189,8 +3189,8 @@ void traceswap(void)
rtk_lock(&lock_trace);
if ((int)(time2gpst(time, NULL) / INT_SWAP_TRAC) ==
(int)(time2gpst(time_trace, NULL) / INT_SWAP_TRAC))
if ((int)(time2gpst(time, nullptr) / INT_SWAP_TRAC) ==
(int)(time2gpst(time_trace, nullptr) / INT_SWAP_TRAC))
{
rtk_unlock(&lock_trace);
return;
@ -3232,7 +3232,7 @@ void traceopen(const char *file)
void traceclose(void)
{
if (fp_trace && fp_trace != stderr) fclose(fp_trace);
fp_trace = NULL;
fp_trace = nullptr;
file_trace[0] = '\0';
}
@ -3614,7 +3614,7 @@ double satwavelen(int sat, int frq, const nav_t *nav)
{
const double freq_glo[] = {FREQ1_GLO, FREQ2_GLO};
const double dfrq_glo[] = {DFRQ1_GLO, DFRQ2_GLO};
int i, sys = satsys(sat, NULL);
int i, sys = satsys(sat, nullptr);
if (sys == SYS_GLO)
{
@ -4132,7 +4132,7 @@ void sunmoonpos(gtime_t tutc, const double *erpv, double *rsun,
tut = timeadd(tutc, erpv[2]); /* utc -> ut1 */
/* sun and moon position in eci */
sunmoonpos_eci(tut, rsun ? rs : NULL, rmoon ? rm : NULL);
sunmoonpos_eci(tut, rsun ? rs : nullptr, rmoon ? rm : nullptr);
/* eci to ecef transformation matrix */
eci2ecef(tutc, erpv, U, &gmst_);
@ -4312,7 +4312,7 @@ int expath(const char *path, char *paths[], int nmax)
for (p = s1; *p; p++) *p = (char)tolower((int)*p);
for (p = s2; *p; p++) *p = (char)tolower((int)*p);
for (p = s1, q = strtok_r(s2, "*", &r); q; q = strtok_r(NULL, "*", &r))
for (p = s1, q = strtok_r(s2, "*", &r); q; q = strtok_r(nullptr, "*", &r))
{
if ((p = strstr(p, q)))
p += strlen(q);
@ -4355,7 +4355,7 @@ void windupcorr(gtime_t time, const double *rs, const double *rr, double *phw)
trace(4, "windupcorr: time=%s\n", time_str(time, 0));
/* sun position in ecef */
sunmoonpos(gpst2utc(time), erpv, rsun, NULL, NULL);
sunmoonpos(gpst2utc(time), erpv, rsun, nullptr, nullptr);
/* unit vector satellite to receiver */
for (i = 0; i < 3; i++) r[i] = rr[i] - rs[i];

View File

@ -67,7 +67,7 @@ static int resamb_TCAR(rtk_t *rtk __attribute((unused)), const obsd_t *obs __att
/* global variables ----------------------------------------------------------*/
static int statlevel = 0; /* rtk status output level (0:off) */
static FILE *fp_stat = NULL; /* rtk status file pointer */
static FILE *fp_stat = nullptr; /* rtk status file pointer */
static char file_stat[1024] = ""; /* rtk status file original path */
static gtime_t time_stat = {0, 0}; /* rtk status file time */
@ -176,7 +176,7 @@ void rtkclosestat(void)
trace(3, "rtkclosestat:\n");
if (fp_stat) fclose(fp_stat);
fp_stat = NULL;
fp_stat = nullptr;
file_stat[0] = '\0';
statlevel = 0;
}
@ -301,8 +301,8 @@ void swapsolstat(void)
gtime_t time = utc2gpst(timeget());
char path[1024];
if ((int)(time2gpst(time, NULL) / INT_SWAP_STAT) ==
(int)(time2gpst(time_stat, NULL) / INT_SWAP_STAT))
if ((int)(time2gpst(time, nullptr) / INT_SWAP_STAT) ==
(int)(time2gpst(time_stat, nullptr) / INT_SWAP_STAT))
{
return;
}
@ -1130,7 +1130,7 @@ int zdres(int base, const obsd_t *obs, int n, const double *rs,
/* troposphere delay model (hydrostatic) */
zhd = tropmodel(obs[0].time, pos, zazel, 0.0);
r += tropmapf(obs[i].time, pos, azel + i * 2, NULL) * zhd;
r += tropmapf(obs[i].time, pos, azel + i * 2, nullptr) * zhd;
/* receiver antenna phase center correction */
antmodel(opt->pcvr + index, opt->antdel[index], azel + i * 2, opt->posopt[1],
@ -1308,7 +1308,7 @@ int ddres(rtk_t *rtk, const nav_t *nav, double dt, const double *x,
{
prcopt_t *opt = &rtk->opt;
double bl, dr[3], posu[3], posr[3], didxi = 0.0, didxj = 0.0, *im;
double *tropr, *tropu, *dtdxr, *dtdxu, *Ri, *Rj, lami, lamj, fi, fj, df, *Hi = NULL;
double *tropr, *tropu, *dtdxr, *dtdxu, *Ri, *Rj, lami, lamj, fi, fj, df, *Hi = nullptr;
int i, j, k, m, f, ff, nv = 0, nb[NFREQ * 4 * 2 + 2] = {0}, b = 0, sysi, sysj, nf = NF_RTK(opt);
trace(3, "ddres : dt=%.1f nx=%d ns=%d\n", dt, rtk->nx, ns);
@ -1921,7 +1921,7 @@ int relpos(rtk_t *rtk, const obsd_t *obs, int nu, int nr,
for (i = 0; i < MAXSAT; i++)
{
rtk->ssat[i].sys = satsys(i + 1, NULL);
rtk->ssat[i].sys = satsys(i + 1, nullptr);
for (j = 0; j < NFREQ; j++) rtk->ssat[i].vsat[j] = rtk->ssat[i].snr[j] = 0;
}
/* satellite positions/clocks */
@ -2009,7 +2009,7 @@ int relpos(rtk_t *rtk, const obsd_t *obs, int nu, int nr,
if (stat != SOLQ_NONE && zdres(0, obs, nu, rs, dts, svh, nav, xp, opt, 0, y, e, azel))
{
/* post-fit residuals for float solution */
nv = ddres(rtk, nav, dt, xp, Pp, sat, y, e, azel, iu, ir, ns, v, NULL, R, vflg);
nv = ddres(rtk, nav, dt, xp, Pp, sat, y, e, azel, iu, ir, ns, v, nullptr, R, vflg);
/* validation of float solution */
if (valpos(rtk, v, R, vflg, nv, 4.0))
@ -2056,7 +2056,7 @@ int relpos(rtk_t *rtk, const obsd_t *obs, int nu, int nr,
if (zdres(0, obs, nu, rs, dts, svh, nav, xa, opt, 0, y, e, azel))
{
/* post-fit reisiduals for fixed solution */
nv = ddres(rtk, nav, dt, xa, NULL, sat, y, e, azel, iu, ir, ns, v, NULL, R, vflg);
nv = ddres(rtk, nav, dt, xa, nullptr, sat, y, e, azel, iu, ir, ns, v, nullptr, R, vflg);
/* validation of fixed solution */
if (valpos(rtk, v, R, vflg, nv, 4.0))
@ -2181,13 +2181,13 @@ void rtkfree(rtk_t *rtk)
rtk->nx = rtk->na = 0;
free(rtk->x);
rtk->x = NULL;
rtk->x = nullptr;
free(rtk->P);
rtk->P = NULL;
rtk->P = nullptr;
free(rtk->xa);
rtk->xa = NULL;
rtk->xa = nullptr;
free(rtk->Pa);
rtk->Pa = NULL;
rtk->Pa = nullptr;
}
@ -2277,7 +2277,7 @@ int rtkpos(rtk_t *rtk, const obsd_t *obs, int n, const nav_t *nav)
time = rtk->sol.time; /* previous epoch */
/* rover position by single point positioning */
if (!pntpos(obs, nu, nav, &rtk->opt, &rtk->sol, NULL, rtk->ssat, msg))
if (!pntpos(obs, nu, nav, &rtk->opt, &rtk->sol, nullptr, rtk->ssat, msg))
{
errmsg(rtk, "point pos error (%s)\n", msg);
if (!rtk->opt.dynamics)
@ -2317,7 +2317,7 @@ int rtkpos(rtk_t *rtk, const obsd_t *obs, int n, const nav_t *nav)
{ /* moving baseline */
/* estimate position/velocity of base station */
if (!pntpos(obs + nu, nr, nav, &rtk->opt, &solb, NULL, NULL, msg))
if (!pntpos(obs + nu, nr, nav, &rtk->opt, &solb, nullptr, nullptr, msg))
{
errmsg(rtk, "base station position error (%s)\n", msg);
return 0;

View File

@ -66,7 +66,7 @@
char *getfield(char *p, int pos)
{
for (pos--; pos > 0; pos--, p++)
if (!(p = strchr(p, ','))) return NULL;
if (!(p = strchr(p, ','))) return nullptr;
return p;
}
@ -579,7 +579,7 @@ void readmsgs(const char *file, int sel, gtime_t ts, gtime_t te,
{
trace(1, "readsbsmsg malloc error: nmax=%d\n", sbs->nmax);
free(sbs->msgs);
sbs->msgs = NULL;
sbs->msgs = nullptr;
sbs->n = sbs->nmax = 0;
fclose(fp);
return;
@ -942,7 +942,7 @@ int sbslongcorr(gtime_t time, int sat, const sbssat_t *sbssat,
return 1;
}
/* if sbas satellite without correction, no correction applied */
if (satsys(sat, NULL) == SYS_SBS) return 1;
if (satsys(sat, nullptr) == SYS_SBS) return 1;
trace(2, "no sbas long-term correction: %s sat=%2d\n", time_str(time, 0), sat);
return 0;

View File

@ -322,7 +322,7 @@ int decode_nmeagga(char **val, int n, sol_t *sol)
/* decode nmea ---------------------------------------------------------------*/
int decode_nmea(char *buff, sol_t *sol)
{
char *p, *q, *val[MAXFIELD] = {0};
char *p, *q, *val[MAXFIELD] = {nullptr};
int n = 0;
trace(4, "decode_nmea: buff=%s\n", buff);
@ -382,7 +382,7 @@ char *decode_soltime(char *buff, const solopt_t *opt, gtime_t *time)
{
*time = utc2gpst(timeadd(*time, -9 * 3600.0));
}
if (!(p = strchr(buff, ':')) || !(p = strchr(p + 1, ':'))) return NULL;
if (!(p = strchr(buff, ':')) || !(p = strchr(p + 1, ':'))) return nullptr;
for (p++; isdigit((int)*p) || *p == '.';) p++;
return p + len;
}
@ -390,10 +390,10 @@ char *decode_soltime(char *buff, const solopt_t *opt, gtime_t *time)
{
if (sscanf(buff, "%lf %lf %lf %lf:%lf:%lf", v, v + 1, v + 2, v + 3, v + 4, v + 5) < 6)
{
return NULL;
return nullptr;
}
*time = timeadd(epoch2time(v), -12.0 * 3600.0);
if (!(p = strchr(buff, ':')) || !(p = strchr(p + 1, ':'))) return NULL;
if (!(p = strchr(buff, ':')) || !(p = strchr(p + 1, ':'))) return nullptr;
for (p++; isdigit((int)*p) || *p == '.';) p++;
return p + len;
}
@ -409,7 +409,7 @@ char *decode_soltime(char *buff, const solopt_t *opt, gtime_t *time)
*time = gpst2time((int)v[0], v[1]);
return p;
}
return NULL;
return nullptr;
}
@ -834,7 +834,7 @@ int sort_solbuf(solbuf_t *solbuf)
{
trace(1, "sort_solbuf: memory allocation error\n");
free(solbuf->data);
solbuf->data = NULL;
solbuf->data = nullptr;
solbuf->n = solbuf->nmax = 0;
return 0;
}
@ -935,7 +935,7 @@ int addsol(solbuf_t *solbuf, const sol_t *sol)
{
trace(1, "addsol: memory allocation error\n");
free(solbuf->data);
solbuf->data = NULL;
solbuf->data = nullptr;
solbuf->n = solbuf->nmax = 0;
return 0;
}
@ -956,7 +956,7 @@ sol_t *getsol(solbuf_t *solbuf, int index)
{
trace(4, "getsol: index=%d\n", index);
if (index < 0 || solbuf->n <= index) return NULL;
if (index < 0 || solbuf->n <= index) return nullptr;
if ((index = solbuf->start + index) >= solbuf->nmax)
{
index -= solbuf->nmax;
@ -981,7 +981,7 @@ void initsolbuf(solbuf_t *solbuf, int cyclic, int nmax)
solbuf->n = solbuf->nmax = solbuf->start = solbuf->end = 0;
solbuf->cyclic = cyclic;
solbuf->time = time0;
solbuf->data = NULL;
solbuf->data = nullptr;
if (cyclic)
{
if (nmax <= 2) nmax = 2;
@ -1006,7 +1006,7 @@ void freesolbuf(solbuf_t *solbuf)
free(solbuf->data);
solbuf->n = solbuf->nmax = solbuf->start = solbuf->end = 0;
solbuf->data = NULL;
solbuf->data = nullptr;
}
@ -1016,7 +1016,7 @@ void freesolstatbuf(solstatbuf_t *solstatbuf)
solstatbuf->n = solstatbuf->nmax = 0;
free(solstatbuf->data);
solstatbuf->data = NULL;
solstatbuf->data = nullptr;
}
@ -1042,7 +1042,7 @@ int sort_solstat(solstatbuf_t *statbuf)
{
trace(1, "sort_solstat: memory allocation error\n");
free(statbuf->data);
statbuf->data = NULL;
statbuf->data = nullptr;
statbuf->n = statbuf->nmax = 0;
return 0;
}
@ -1115,7 +1115,7 @@ void addsolstat(solstatbuf_t *statbuf, const solstat_t *stat)
{
trace(1, "addsolstat: memory allocation error\n");
free(statbuf->data);
statbuf->data = NULL;
statbuf->data = nullptr;
statbuf->n = statbuf->nmax = 0;
return;
}
@ -1169,7 +1169,7 @@ int readsolstatt(char *files[], int nfile, gtime_t ts, gtime_t te,
trace(3, "readsolstatt: nfile=%d\n", nfile);
statbuf->n = statbuf->nmax = 0;
statbuf->data = NULL;
statbuf->data = nullptr;
for (i = 0; i < nfile; i++)
{

View File

@ -51,9 +51,7 @@ HybridObservables::HybridObservables(ConfigurationInterface* configuration,
}
HybridObservables::~HybridObservables()
{
}
HybridObservables::~HybridObservables() = default;
void HybridObservables::connect(gr::top_block_sptr top_block)

View File

@ -270,8 +270,8 @@ int32_t hybrid_observables_cc::save_matfile()
filename.erase(filename.end() - 4, filename.end());
}
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {static_cast<size_t>(d_nchannels_out), static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("RX_time", MAT_C_DOUBLE, MAT_T_DOUBLE, 2, dims, RX_time_aux, MAT_F_DONT_COPY_DATA);

View File

@ -113,7 +113,7 @@ DirectResamplerConditioner::DirectResamplerConditioner(
}
DirectResamplerConditioner::~DirectResamplerConditioner() {}
DirectResamplerConditioner::~DirectResamplerConditioner() = default;
void DirectResamplerConditioner::connect(gr::top_block_sptr top_block)

View File

@ -106,7 +106,9 @@ MmseResamplerConditioner::MmseResamplerConditioner(
}
MmseResamplerConditioner::~MmseResamplerConditioner() {}
MmseResamplerConditioner::~MmseResamplerConditioner() = default;
void MmseResamplerConditioner::connect(gr::top_block_sptr top_block)
{
if (dump_)

View File

@ -73,9 +73,7 @@ direct_resampler_conditioner_cb::direct_resampler_conditioner_cb(
}
direct_resampler_conditioner_cb::~direct_resampler_conditioner_cb()
{
}
direct_resampler_conditioner_cb::~direct_resampler_conditioner_cb() = default;
void direct_resampler_conditioner_cb::forecast(int noutput_items,

View File

@ -71,9 +71,7 @@ direct_resampler_conditioner_cc::direct_resampler_conditioner_cc(
}
direct_resampler_conditioner_cc::~direct_resampler_conditioner_cc()
{
}
direct_resampler_conditioner_cc::~direct_resampler_conditioner_cc() = default;
void direct_resampler_conditioner_cc::forecast(int noutput_items,

View File

@ -71,9 +71,7 @@ direct_resampler_conditioner_cs::direct_resampler_conditioner_cs(
}
direct_resampler_conditioner_cs::~direct_resampler_conditioner_cs()
{
}
direct_resampler_conditioner_cs::~direct_resampler_conditioner_cs() = default;
void direct_resampler_conditioner_cs::forecast(int noutput_items,

View File

@ -149,9 +149,7 @@ SignalGenerator::SignalGenerator(ConfigurationInterface* configuration,
}
SignalGenerator::~SignalGenerator()
{
}
SignalGenerator::~SignalGenerator() = default;
void SignalGenerator::connect(gr::top_block_sptr top_block)

View File

@ -251,9 +251,7 @@ FileSignalSource::FileSignalSource(ConfigurationInterface* configuration,
}
FileSignalSource::~FileSignalSource()
{
}
FileSignalSource::~FileSignalSource() = default;
void FileSignalSource::connect(gr::top_block_sptr top_block)

View File

@ -83,9 +83,7 @@ LabsatSignalSource::LabsatSignalSource(ConfigurationInterface* configuration,
}
LabsatSignalSource::~LabsatSignalSource()
{
}
LabsatSignalSource::~LabsatSignalSource() = default;
void LabsatSignalSource::connect(gr::top_block_sptr top_block)

View File

@ -177,9 +177,7 @@ NsrFileSignalSource::NsrFileSignalSource(ConfigurationInterface* configuration,
}
NsrFileSignalSource::~NsrFileSignalSource()
{
}
NsrFileSignalSource::~NsrFileSignalSource() = default;
void NsrFileSignalSource::connect(gr::top_block_sptr top_block)

View File

@ -139,9 +139,7 @@ RtlTcpSignalSource::RtlTcpSignalSource(ConfigurationInterface* configuration,
}
RtlTcpSignalSource::~RtlTcpSignalSource()
{
}
RtlTcpSignalSource::~RtlTcpSignalSource() = default;
void RtlTcpSignalSource::MakeBlock()

View File

@ -176,9 +176,7 @@ SpirFileSignalSource::SpirFileSignalSource(ConfigurationInterface* configuration
}
SpirFileSignalSource::~SpirFileSignalSource()
{
}
SpirFileSignalSource::~SpirFileSignalSource() = default;
void SpirFileSignalSource::connect(gr::top_block_sptr top_block)

View File

@ -181,9 +181,7 @@ SpirGSS6450FileSignalSource::SpirGSS6450FileSignalSource(ConfigurationInterface*
}
SpirGSS6450FileSignalSource::~SpirGSS6450FileSignalSource()
{
}
SpirGSS6450FileSignalSource::~SpirGSS6450FileSignalSource() = default;
void SpirGSS6450FileSignalSource::connect(gr::top_block_sptr top_block)

View File

@ -246,9 +246,7 @@ TwoBitPackedFileSignalSource::TwoBitPackedFileSignalSource(ConfigurationInterfac
}
TwoBitPackedFileSignalSource::~TwoBitPackedFileSignalSource()
{
}
TwoBitPackedFileSignalSource::~TwoBitPackedFileSignalSource() = default;
void TwoBitPackedFileSignalSource::connect(gr::top_block_sptr top_block)

View File

@ -239,9 +239,7 @@ UhdSignalSource::UhdSignalSource(ConfigurationInterface* configuration,
}
UhdSignalSource::~UhdSignalSource()
{
}
UhdSignalSource::~UhdSignalSource() = default;
void UhdSignalSource::connect(gr::top_block_sptr top_block)

View File

@ -131,9 +131,7 @@ unpack_2bit_samples::unpack_2bit_samples(bool big_endian_bytes,
}
unpack_2bit_samples::~unpack_2bit_samples()
{
}
unpack_2bit_samples::~unpack_2bit_samples() = default;
int unpack_2bit_samples::work(int noutput_items,

View File

@ -56,9 +56,7 @@ unpack_byte_2bit_cpx_samples::unpack_byte_2bit_cpx_samples() : sync_interpolator
}
unpack_byte_2bit_cpx_samples::~unpack_byte_2bit_cpx_samples()
{
}
unpack_byte_2bit_cpx_samples::~unpack_byte_2bit_cpx_samples() = default;
int unpack_byte_2bit_cpx_samples::work(int noutput_items,

View File

@ -52,9 +52,7 @@ unpack_byte_2bit_samples::unpack_byte_2bit_samples() : sync_interpolator("unpack
}
unpack_byte_2bit_samples::~unpack_byte_2bit_samples()
{
}
unpack_byte_2bit_samples::~unpack_byte_2bit_samples() = default;
int unpack_byte_2bit_samples::work(int noutput_items,

View File

@ -47,9 +47,7 @@ unpack_byte_4bit_samples::unpack_byte_4bit_samples() : sync_interpolator("unpack
}
unpack_byte_4bit_samples::~unpack_byte_4bit_samples()
{
}
unpack_byte_4bit_samples::~unpack_byte_4bit_samples() = default;
int unpack_byte_4bit_samples::work(int noutput_items,

View File

@ -47,9 +47,7 @@ unpack_intspir_1bit_samples::unpack_intspir_1bit_samples() : sync_interpolator("
}
unpack_intspir_1bit_samples::~unpack_intspir_1bit_samples()
{
}
unpack_intspir_1bit_samples::~unpack_intspir_1bit_samples() = default;
int unpack_intspir_1bit_samples::work(int noutput_items,

View File

@ -49,9 +49,8 @@ unpack_spir_gss6450_samples::unpack_spir_gss6450_samples(unsigned int adc_nbit)
}
unpack_spir_gss6450_samples::~unpack_spir_gss6450_samples()
{
}
unpack_spir_gss6450_samples::~unpack_spir_gss6450_samples() = default;
void unpack_spir_gss6450_samples::decode_4bits_word(uint32_t input_uint32, gr_complex* out, int adc_bits)
{

View File

@ -69,9 +69,7 @@ GalileoE1BTelemetryDecoder::GalileoE1BTelemetryDecoder(ConfigurationInterface* c
}
GalileoE1BTelemetryDecoder::~GalileoE1BTelemetryDecoder()
{
}
GalileoE1BTelemetryDecoder::~GalileoE1BTelemetryDecoder() = default;
void GalileoE1BTelemetryDecoder::set_satellite(const Gnss_Satellite& satellite)

View File

@ -72,9 +72,7 @@ GalileoE5aTelemetryDecoder::GalileoE5aTelemetryDecoder(ConfigurationInterface* c
}
GalileoE5aTelemetryDecoder::~GalileoE5aTelemetryDecoder()
{
}
GalileoE5aTelemetryDecoder::~GalileoE5aTelemetryDecoder() = default;
void GalileoE5aTelemetryDecoder::set_satellite(const Gnss_Satellite& satellite)

View File

@ -68,9 +68,7 @@ GlonassL1CaTelemetryDecoder::GlonassL1CaTelemetryDecoder(ConfigurationInterface*
}
GlonassL1CaTelemetryDecoder::~GlonassL1CaTelemetryDecoder()
{
}
GlonassL1CaTelemetryDecoder::~GlonassL1CaTelemetryDecoder() = default;
void GlonassL1CaTelemetryDecoder::set_satellite(const Gnss_Satellite& satellite)

View File

@ -67,9 +67,7 @@ GlonassL2CaTelemetryDecoder::GlonassL2CaTelemetryDecoder(ConfigurationInterface*
}
GlonassL2CaTelemetryDecoder::~GlonassL2CaTelemetryDecoder()
{
}
GlonassL2CaTelemetryDecoder::~GlonassL2CaTelemetryDecoder() = default;
void GlonassL2CaTelemetryDecoder::set_satellite(const Gnss_Satellite& satellite)

View File

@ -68,9 +68,7 @@ GpsL1CaTelemetryDecoder::GpsL1CaTelemetryDecoder(ConfigurationInterface* configu
}
GpsL1CaTelemetryDecoder::~GpsL1CaTelemetryDecoder()
{
}
GpsL1CaTelemetryDecoder::~GpsL1CaTelemetryDecoder() = default;
void GpsL1CaTelemetryDecoder::set_satellite(const Gnss_Satellite& satellite)

View File

@ -68,9 +68,7 @@ GpsL2CTelemetryDecoder::GpsL2CTelemetryDecoder(ConfigurationInterface* configura
}
GpsL2CTelemetryDecoder::~GpsL2CTelemetryDecoder()
{
}
GpsL2CTelemetryDecoder::~GpsL2CTelemetryDecoder() = default;
void GpsL2CTelemetryDecoder::set_satellite(const Gnss_Satellite& satellite)

View File

@ -64,9 +64,7 @@ GpsL5TelemetryDecoder::GpsL5TelemetryDecoder(ConfigurationInterface* configurati
}
GpsL5TelemetryDecoder::~GpsL5TelemetryDecoder()
{
}
GpsL5TelemetryDecoder::~GpsL5TelemetryDecoder() = default;
void GpsL5TelemetryDecoder::set_satellite(const Gnss_Satellite& satellite)

View File

@ -66,9 +66,7 @@ SbasL1TelemetryDecoder::SbasL1TelemetryDecoder(ConfigurationInterface* configura
}
SbasL1TelemetryDecoder::~SbasL1TelemetryDecoder()
{
}
SbasL1TelemetryDecoder::~SbasL1TelemetryDecoder() = default;
void SbasL1TelemetryDecoder::set_satellite(const Gnss_Satellite& satellite)

View File

@ -110,9 +110,7 @@ sbas_l1_telemetry_decoder_cc::sample_aligner::sample_aligner()
}
sbas_l1_telemetry_decoder_cc::sample_aligner::~sample_aligner()
{
}
sbas_l1_telemetry_decoder_cc::sample_aligner::~sample_aligner() = default;
void sbas_l1_telemetry_decoder_cc::sample_aligner::reset()

View File

@ -45,9 +45,6 @@
using google::LogMessage;
void GalileoE1DllPllVemlTracking::stop_tracking()
{
}
GalileoE1DllPllVemlTracking::GalileoE1DllPllVemlTracking(
ConfigurationInterface* configuration, std::string role,
@ -157,7 +154,10 @@ GalileoE1DllPllVemlTracking::GalileoE1DllPllVemlTracking(
}
GalileoE1DllPllVemlTracking::~GalileoE1DllPllVemlTracking()
GalileoE1DllPllVemlTracking::~GalileoE1DllPllVemlTracking() = default;
void GalileoE1DllPllVemlTracking::stop_tracking()
{
}

View File

@ -44,9 +44,6 @@
using google::LogMessage;
void GalileoE1TcpConnectorTracking::stop_tracking()
{
}
GalileoE1TcpConnectorTracking::GalileoE1TcpConnectorTracking(
ConfigurationInterface* configuration, std::string role,
@ -113,7 +110,10 @@ GalileoE1TcpConnectorTracking::GalileoE1TcpConnectorTracking(
}
GalileoE1TcpConnectorTracking::~GalileoE1TcpConnectorTracking()
GalileoE1TcpConnectorTracking::~GalileoE1TcpConnectorTracking() = default;
void GalileoE1TcpConnectorTracking::stop_tracking()
{
}

View File

@ -45,9 +45,6 @@
using google::LogMessage;
void GalileoE5aDllPllTracking::stop_tracking()
{
}
GalileoE5aDllPllTracking::GalileoE5aDllPllTracking(
ConfigurationInterface* configuration, std::string role,
@ -154,7 +151,10 @@ GalileoE5aDllPllTracking::GalileoE5aDllPllTracking(
}
GalileoE5aDllPllTracking::~GalileoE5aDllPllTracking()
GalileoE5aDllPllTracking::~GalileoE5aDllPllTracking() = default;
void GalileoE5aDllPllTracking::stop_tracking()
{
}

View File

@ -46,9 +46,6 @@
using google::LogMessage;
void GlonassL1CaDllPllCAidTracking::stop_tracking()
{
}
GlonassL1CaDllPllCAidTracking::GlonassL1CaDllPllCAidTracking(
ConfigurationInterface* configuration, std::string role,
@ -135,7 +132,10 @@ GlonassL1CaDllPllCAidTracking::GlonassL1CaDllPllCAidTracking(
}
GlonassL1CaDllPllCAidTracking::~GlonassL1CaDllPllCAidTracking()
GlonassL1CaDllPllCAidTracking::~GlonassL1CaDllPllCAidTracking() = default;
void GlonassL1CaDllPllCAidTracking::stop_tracking()
{
}

View File

@ -45,9 +45,6 @@
using google::LogMessage;
void GlonassL1CaDllPllTracking::stop_tracking()
{
}
GlonassL1CaDllPllTracking::GlonassL1CaDllPllTracking(
ConfigurationInterface* configuration, std::string role,
@ -108,7 +105,10 @@ GlonassL1CaDllPllTracking::GlonassL1CaDllPllTracking(
}
GlonassL1CaDllPllTracking::~GlonassL1CaDllPllTracking()
GlonassL1CaDllPllTracking::~GlonassL1CaDllPllTracking() = default;
void GlonassL1CaDllPllTracking::stop_tracking()
{
}

View File

@ -44,9 +44,6 @@
using google::LogMessage;
void GlonassL2CaDllPllCAidTracking::stop_tracking()
{
}
GlonassL2CaDllPllCAidTracking::GlonassL2CaDllPllCAidTracking(
ConfigurationInterface* configuration, std::string role,
@ -133,7 +130,10 @@ GlonassL2CaDllPllCAidTracking::GlonassL2CaDllPllCAidTracking(
}
GlonassL2CaDllPllCAidTracking::~GlonassL2CaDllPllCAidTracking()
GlonassL2CaDllPllCAidTracking::~GlonassL2CaDllPllCAidTracking() = default;
void GlonassL2CaDllPllCAidTracking::stop_tracking()
{
}

View File

@ -43,9 +43,6 @@
using google::LogMessage;
void GlonassL2CaDllPllTracking::stop_tracking()
{
}
GlonassL2CaDllPllTracking::GlonassL2CaDllPllTracking(
ConfigurationInterface* configuration, std::string role,
@ -106,7 +103,10 @@ GlonassL2CaDllPllTracking::GlonassL2CaDllPllTracking(
}
GlonassL2CaDllPllTracking::~GlonassL2CaDllPllTracking()
GlonassL2CaDllPllTracking::~GlonassL2CaDllPllTracking() = default;
void GlonassL2CaDllPllTracking::stop_tracking()
{
}

View File

@ -45,9 +45,6 @@
using google::LogMessage;
void GpsL1CaDllPllCAidTracking::stop_tracking()
{
}
GpsL1CaDllPllCAidTracking::GpsL1CaDllPllCAidTracking(
ConfigurationInterface* configuration, std::string role,
@ -134,7 +131,10 @@ GpsL1CaDllPllCAidTracking::GpsL1CaDllPllCAidTracking(
}
GpsL1CaDllPllCAidTracking::~GpsL1CaDllPllCAidTracking()
GpsL1CaDllPllCAidTracking::~GpsL1CaDllPllCAidTracking() = default;
void GpsL1CaDllPllCAidTracking::stop_tracking()
{
}

View File

@ -45,10 +45,6 @@
using google::LogMessage;
void GpsL1CaDllPllTracking::stop_tracking()
{
tracking_->stop_tracking();
}
GpsL1CaDllPllTracking::GpsL1CaDllPllTracking(
ConfigurationInterface* configuration, std::string role,
@ -159,8 +155,12 @@ GpsL1CaDllPllTracking::GpsL1CaDllPllTracking(
}
GpsL1CaDllPllTracking::~GpsL1CaDllPllTracking()
GpsL1CaDllPllTracking::~GpsL1CaDllPllTracking() = default;
void GpsL1CaDllPllTracking::stop_tracking()
{
tracking_->stop_tracking();
}

View File

@ -47,9 +47,6 @@
using google::LogMessage;
void GpsL1CaKfTracking::stop_tracking()
{
}
GpsL1CaKfTracking::GpsL1CaKfTracking(
ConfigurationInterface* configuration, std::string role,
@ -121,7 +118,10 @@ GpsL1CaKfTracking::GpsL1CaKfTracking(
}
GpsL1CaKfTracking::~GpsL1CaKfTracking()
GpsL1CaKfTracking::~GpsL1CaKfTracking() = default;
void GpsL1CaKfTracking::stop_tracking()
{
}

View File

@ -43,9 +43,6 @@
using google::LogMessage;
void GpsL1CaTcpConnectorTracking::stop_tracking()
{
}
GpsL1CaTcpConnectorTracking::GpsL1CaTcpConnectorTracking(
ConfigurationInterface* configuration, std::string role,
@ -103,7 +100,10 @@ GpsL1CaTcpConnectorTracking::GpsL1CaTcpConnectorTracking(
}
GpsL1CaTcpConnectorTracking::~GpsL1CaTcpConnectorTracking()
GpsL1CaTcpConnectorTracking::~GpsL1CaTcpConnectorTracking() = default;
void GpsL1CaTcpConnectorTracking::stop_tracking()
{
}

View File

@ -45,9 +45,6 @@
using google::LogMessage;
void GpsL2MDllPllTracking::stop_tracking()
{
}
GpsL2MDllPllTracking::GpsL2MDllPllTracking(
ConfigurationInterface* configuration, std::string role,
@ -135,11 +132,13 @@ GpsL2MDllPllTracking::GpsL2MDllPllTracking(
}
GpsL2MDllPllTracking::~GpsL2MDllPllTracking()
GpsL2MDllPllTracking::~GpsL2MDllPllTracking() = default;
void GpsL2MDllPllTracking::stop_tracking()
{
}
void GpsL2MDllPllTracking::start_tracking()
{
tracking_->start_tracking();

View File

@ -45,9 +45,6 @@
using google::LogMessage;
void GpsL5DllPllTracking::stop_tracking()
{
}
GpsL5DllPllTracking::GpsL5DllPllTracking(
ConfigurationInterface* configuration, std::string role,
@ -154,7 +151,10 @@ GpsL5DllPllTracking::GpsL5DllPllTracking(
}
GpsL5DllPllTracking::~GpsL5DllPllTracking()
GpsL5DllPllTracking::~GpsL5DllPllTracking() = default;
void GpsL5DllPllTracking::stop_tracking()
{
}

View File

@ -1171,8 +1171,8 @@ int32_t dll_pll_veml_tracking::save_matfile()
std::string filename = dump_filename_;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_VE", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_VE, 0);

View File

@ -172,7 +172,7 @@ Galileo_E1_Tcp_Connector_Tracking_cc::Galileo_E1_Tcp_Connector_Tracking_cc(
d_carrier_lock_threshold = FLAGS_carrier_lock_th;
systemName["E"] = std::string("Galileo");
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_next_rem_code_phase_samples = 0;
d_acq_code_phase_samples = 0.0;

View File

@ -185,7 +185,7 @@ glonass_l1_ca_dll_pll_c_aid_tracking_cc::glonass_l1_ca_dll_pll_c_aid_tracking_cc
set_relative_rate(1.0 / static_cast<double>(d_vector_length));
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_acq_code_phase_samples = 0.0;
d_acq_carrier_doppler_hz = 0.0;
@ -456,8 +456,8 @@ int32_t glonass_l1_ca_dll_pll_c_aid_tracking_cc::save_matfile()
std::string filename = d_dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_E", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_E, 0);

View File

@ -183,7 +183,7 @@ glonass_l1_ca_dll_pll_c_aid_tracking_sc::glonass_l1_ca_dll_pll_c_aid_tracking_sc
set_relative_rate(1.0 / static_cast<double>(d_vector_length));
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_acq_code_phase_samples = 0.0;
d_acq_carrier_doppler_hz = 0.0;
@ -410,8 +410,8 @@ int32_t glonass_l1_ca_dll_pll_c_aid_tracking_sc::save_matfile()
std::string filename = d_dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_E", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_E, 0);

View File

@ -154,7 +154,7 @@ Glonass_L1_Ca_Dll_Pll_Tracking_cc::Glonass_L1_Ca_Dll_Pll_Tracking_cc(
systemName["R"] = std::string("Glonass");
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_acq_code_phase_samples = 0.0;
d_acq_carrier_doppler_hz = 0.0;
@ -408,8 +408,8 @@ int32_t Glonass_L1_Ca_Dll_Pll_Tracking_cc::save_matfile()
std::string filename = d_dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_E", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_E, 0);

View File

@ -182,7 +182,7 @@ glonass_l2_ca_dll_pll_c_aid_tracking_cc::glonass_l2_ca_dll_pll_c_aid_tracking_cc
set_relative_rate(1.0 / static_cast<double>(d_vector_length));
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_acq_code_phase_samples = 0.0;
d_acq_carrier_doppler_hz = 0.0;
@ -453,8 +453,8 @@ int32_t glonass_l2_ca_dll_pll_c_aid_tracking_cc::save_matfile()
std::string filename = d_dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_E", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_E, 0);

View File

@ -182,7 +182,7 @@ glonass_l2_ca_dll_pll_c_aid_tracking_sc::glonass_l2_ca_dll_pll_c_aid_tracking_sc
set_relative_rate(1.0 / static_cast<double>(d_vector_length));
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_acq_code_phase_samples = 0.0;
d_acq_carrier_doppler_hz = 0.0;
@ -409,8 +409,8 @@ int32_t glonass_l2_ca_dll_pll_c_aid_tracking_sc::save_matfile()
std::string filename = d_dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_E", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_E, 0);

View File

@ -154,7 +154,7 @@ Glonass_L2_Ca_Dll_Pll_Tracking_cc::Glonass_L2_Ca_Dll_Pll_Tracking_cc(
systemName["R"] = std::string("Glonass");
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_acq_code_phase_samples = 0.0;
d_acq_carrier_doppler_hz = 0.0;
@ -408,8 +408,8 @@ int32_t Glonass_L2_Ca_Dll_Pll_Tracking_cc::save_matfile()
std::string filename = d_dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_E", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_E, 0);

View File

@ -175,7 +175,7 @@ gps_l1_ca_dll_pll_c_aid_tracking_cc::gps_l1_ca_dll_pll_c_aid_tracking_cc(
set_relative_rate(1.0 / static_cast<double>(d_vector_length));
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_acq_code_phase_samples = 0.0;
d_acq_carrier_doppler_hz = 0.0;
@ -435,8 +435,8 @@ int32_t gps_l1_ca_dll_pll_c_aid_tracking_cc::save_matfile()
std::string filename = d_dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_E", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_E, 0);

View File

@ -175,7 +175,7 @@ gps_l1_ca_dll_pll_c_aid_tracking_sc::gps_l1_ca_dll_pll_c_aid_tracking_sc(
set_relative_rate(1.0 / static_cast<double>(d_vector_length));
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_acq_code_phase_samples = 0.0;
d_acq_carrier_doppler_hz = 0.0;
@ -437,8 +437,8 @@ int32_t gps_l1_ca_dll_pll_c_aid_tracking_sc::save_matfile()
std::string filename = d_dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<int64_t *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_E", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_E, 0);

View File

@ -172,7 +172,7 @@ Gps_L1_Ca_Kf_Tracking_cc::Gps_L1_Ca_Kf_Tracking_cc(
systemName["G"] = std::string("GPS");
systemName["S"] = std::string("SBAS");
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_acq_code_phase_samples = 0.0;
d_acq_carrier_doppler_hz = 0.0;
@ -516,8 +516,8 @@ int32_t Gps_L1_Ca_Kf_Tracking_cc::save_matfile()
std::string filename = d_dump_filename;
filename.erase(filename.length() - 4, 4);
filename.append(".mat");
matfp = Mat_CreateVer(filename.c_str(), NULL, MAT_FT_MAT73);
if (reinterpret_cast<long *>(matfp) != NULL)
matfp = Mat_CreateVer(filename.c_str(), nullptr, MAT_FT_MAT73);
if (reinterpret_cast<long *>(matfp) != nullptr)
{
size_t dims[2] = {1, static_cast<size_t>(num_epoch)};
matvar = Mat_VarCreate("abs_VE", MAT_C_SINGLE, MAT_T_SINGLE, 2, dims, abs_VE, 0);

View File

@ -163,7 +163,7 @@ Gps_L1_Ca_Tcp_Connector_Tracking_cc::Gps_L1_Ca_Tcp_Connector_Tracking_cc(
systemName["E"] = std::string("Galileo");
systemName["C"] = std::string("Compass");
d_acquisition_gnss_synchro = 0;
d_acquisition_gnss_synchro = nullptr;
d_channel = 0;
d_next_rem_code_phase_samples = 0;
d_acq_code_phase_samples = 0.0;

View File

@ -74,9 +74,7 @@ Bayesian_estimator::Bayesian_estimator(const arma::vec& mu_prior_0, int kappa_pr
Psi_est = Psi_prior;
}
Bayesian_estimator::~Bayesian_estimator()
{
}
Bayesian_estimator::~Bayesian_estimator() = default;
void Bayesian_estimator::init(const arma::mat& mu_prior_0, int kappa_prior_0, int nu_prior_0, const arma::mat& Psi_prior_0)
{

View File

@ -37,4 +37,4 @@ tcp_packet_data::tcp_packet_data()
proc_pack_carrier_doppler_hz = 0;
}
tcp_packet_data::~tcp_packet_data() {}
tcp_packet_data::~tcp_packet_data() = default;

View File

@ -72,21 +72,23 @@ float Tracking_2nd_DLL_filter::get_code_nco(float DLL_discriminator)
return code_nco;
}
Tracking_2nd_DLL_filter::Tracking_2nd_DLL_filter(float pdi_code)
{
d_pdi_code = pdi_code; // Summation interval for code
d_dlldampingratio = 0.7;
}
Tracking_2nd_DLL_filter::Tracking_2nd_DLL_filter()
{
d_pdi_code = 0.001; // Summation interval for code
d_dlldampingratio = 0.7;
}
Tracking_2nd_DLL_filter::~Tracking_2nd_DLL_filter()
{
}
Tracking_2nd_DLL_filter::~Tracking_2nd_DLL_filter() = default;
void Tracking_2nd_DLL_filter::set_pdi(float pdi_code)
{

View File

@ -77,6 +77,7 @@ float Tracking_2nd_PLL_filter::get_carrier_nco(float PLL_discriminator)
return carr_nco;
}
Tracking_2nd_PLL_filter::Tracking_2nd_PLL_filter(float pdi_carr)
{
//--- PLL variables --------------------------------------------------------
@ -94,9 +95,8 @@ Tracking_2nd_PLL_filter::Tracking_2nd_PLL_filter()
}
Tracking_2nd_PLL_filter::~Tracking_2nd_PLL_filter()
{
}
Tracking_2nd_PLL_filter::~Tracking_2nd_PLL_filter() = default;
void Tracking_2nd_PLL_filter::set_pdi(float pdi_carr)
{

View File

@ -131,6 +131,4 @@ Tracking_FLL_PLL_filter::Tracking_FLL_PLL_filter()
}
Tracking_FLL_PLL_filter::~Tracking_FLL_PLL_filter()
{
}
Tracking_FLL_PLL_filter::~Tracking_FLL_PLL_filter() = default;

View File

@ -52,7 +52,7 @@
class ConfigurationInterface
{
public:
virtual ~ConfigurationInterface() {}
virtual ~ConfigurationInterface() = default;
virtual std::string property(std::string property_name, std::string default_value) = 0;
virtual bool property(std::string property_name, bool default_value) = 0;
virtual int64_t property(std::string property_name, int64_t default_value) = 0;

View File

@ -53,7 +53,7 @@
class GNSSBlockInterface
{
public:
virtual ~GNSSBlockInterface() {}
virtual ~GNSSBlockInterface() = default;
virtual std::string role() = 0;
virtual std::string implementation() = 0;
virtual size_t item_size() = 0;

Some files were not shown because too many files have changed in this diff Show More