mirror of
https://github.com/gnss-sdr/gnss-sdr
synced 2024-12-15 12:40:35 +00:00
Fix typos detected by codespell
This commit is contained in:
parent
c4f4f80b45
commit
0400034d14
@ -316,7 +316,7 @@ int pcps_quicksync_acquisition_cc::general_work(int noutput_items,
|
||||
gr_complex* corr_output = static_cast<gr_complex*>(volk_gnsssdr_malloc(d_samples_per_code * sizeof(gr_complex), volk_gnsssdr_get_alignment()));
|
||||
|
||||
/*Stores a copy of the folded version of the signal.This is used for
|
||||
the FFT operations in future steps of excecution*/
|
||||
the FFT operations in future steps of execution*/
|
||||
// gr_complex in_folded[d_fft_size];
|
||||
float fft_normalization_factor = static_cast<float>(d_fft_size) * static_cast<float>(d_fft_size);
|
||||
|
||||
@ -468,7 +468,7 @@ int pcps_quicksync_acquisition_cc::general_work(int noutput_items,
|
||||
if (d_dump)
|
||||
{
|
||||
/*Since QuickSYnc performs a folded correlation in frequency by means
|
||||
of the FFT, it is esential to also keep the values obtained from the
|
||||
of the FFT, it is essential to also keep the values obtained from the
|
||||
possible delay to show how it is maximize*/
|
||||
std::stringstream filename;
|
||||
std::streamsize n = sizeof(float) * (d_fft_size); // complex file write
|
||||
|
@ -92,7 +92,7 @@ private:
|
||||
int d_fd; // driver descriptor
|
||||
volatile unsigned *d_map_base; // driver memory map
|
||||
lv_16sc_t *d_all_fft_codes; // memory that contains all the code ffts
|
||||
unsigned int d_vector_length; // number of samples incluing padding and number of ms
|
||||
unsigned int d_vector_length; // number of samples including padding and number of ms
|
||||
unsigned int d_nsamples; // number of samples not including padding
|
||||
unsigned int d_select_queue; // queue selection
|
||||
std::string d_device_name; // HW device name
|
||||
|
@ -1,6 +1,6 @@
|
||||
/*!
|
||||
* \file notch_filter_lite.h
|
||||
* \brief Adapts a ligth version of a multistate notch filter
|
||||
* \brief Adapts a light version of a multistate notch filter
|
||||
* \author Antonio Ramos, 2017. antonio.ramosdet(at)gmail.com
|
||||
*
|
||||
* Detailed description of the file here if needed.
|
||||
|
@ -1,6 +1,6 @@
|
||||
/*!
|
||||
* \file notch_lite_cc.h
|
||||
* \brief Implements a notch filter ligth algorithm
|
||||
* \brief Implements a notch filter light algorithm
|
||||
* \author Antonio Ramos (antonio.ramosdet(at)gmail.com)
|
||||
*
|
||||
* -------------------------------------------------------------------------
|
||||
@ -43,7 +43,7 @@ typedef boost::shared_ptr<NotchLite> notch_lite_sptr;
|
||||
notch_lite_sptr make_notch_filter_lite(float p_c_factor, float pfa, int length_, int n_segments_est, int n_segments_reset, int n_segments_coeff);
|
||||
|
||||
/*!
|
||||
* \brief This class implements a real-time software-defined multi state notch filter ligth version
|
||||
* \brief This class implements a real-time software-defined multi state notch filter light version
|
||||
*/
|
||||
|
||||
class NotchLite : public gr::block
|
||||
|
File diff suppressed because it is too large
Load Diff
@ -663,7 +663,7 @@ int satpos_sbas(gtime_t time, gtime_t teph, int sat, const nav_t *nav,
|
||||
*svh = -1;
|
||||
return 0;
|
||||
}
|
||||
/* satellite postion and clock by broadcast ephemeris */
|
||||
/* satellite position and clock by broadcast ephemeris */
|
||||
if (!ephpos(time, teph, sat, nav, sbs->lcorr.iode, rs, dts, var, svh)) return 0;
|
||||
|
||||
/* sbas satellite correction (long term and fast) */
|
||||
@ -734,7 +734,7 @@ int satpos_ssr(gtime_t time, gtime_t teph, int sat, const nav_t *nav,
|
||||
*svh = -1;
|
||||
return 0;
|
||||
}
|
||||
/* satellite postion and clock by broadcast ephemeris */
|
||||
/* satellite position and clock by broadcast ephemeris */
|
||||
if (!ephpos(time, teph, sat, nav, ssr->iode, rs, dts, var, svh)) return 0;
|
||||
|
||||
/* satellite clock for gps, galileo and qzss */
|
||||
|
@ -768,7 +768,7 @@ int pntpos(const obsd_t *obs, int n, const nav_t *nav,
|
||||
opt_.ionoopt = IONOOPT_BRDC;
|
||||
opt_.tropopt = TROPOPT_SAAS;
|
||||
}
|
||||
/* satellite positons, velocities and clocks */
|
||||
/* satellite positions, velocities and clocks */
|
||||
satposs(sol->time, obs, n, nav, opt_.sateph, rs, dts, var, svh);
|
||||
|
||||
/* estimate receiver position with pseudorange */
|
||||
|
@ -425,7 +425,7 @@ int fix_amb_ROUND(rtk_t *rtk, int *sat1, int *sat2, const int *NW, int n)
|
||||
sat2[m] = sat2[i];
|
||||
NC[m++] = BC;
|
||||
}
|
||||
/* select fixed ambiguities by dependancy check */
|
||||
/* select fixed ambiguities by dependency check */
|
||||
m = sel_amb(sat1, sat2, NC, var, m);
|
||||
|
||||
/* fixed solution */
|
||||
|
@ -79,7 +79,7 @@
|
||||
|
||||
const double MIN_ARC_GAP = 300.0; /* min arc gap (s) */
|
||||
const double CONST_AMB = 0.001; /* constraint to fixed ambiguity */
|
||||
const double THRES_RES = 0.3; /* threashold of residuals test (m) */
|
||||
const double THRES_RES = 0.3; /* threshold of residuals test (m) */
|
||||
const double LOG_PI = 1.14472988584940017; /* log(pi) */
|
||||
const double SQRT2 = 1.41421356237309510; /* sqrt(2) */
|
||||
|
||||
|
@ -315,7 +315,7 @@ int input_rtcm3(rtcm_t *rtcm, unsigned char data)
|
||||
|
||||
|
||||
/* input rtcm 2 message from file ----------------------------------------------
|
||||
* fetch next rtcm 2 message and input a messsage from file
|
||||
* fetch next rtcm 2 message and input a message from file
|
||||
* args : rtcm_t *rtcm IO rtcm control struct
|
||||
* FILE *fp I file pointer
|
||||
* return : status (-2: end of file, -1...10: same as above)
|
||||
@ -337,7 +337,7 @@ int input_rtcm2f(rtcm_t *rtcm, FILE *fp)
|
||||
|
||||
|
||||
/* input rtcm 3 message from file ----------------------------------------------
|
||||
* fetch next rtcm 3 message and input a messsage from file
|
||||
* fetch next rtcm 3 message and input a message from file
|
||||
* args : rtcm_t *rtcm IO rtcm control struct
|
||||
* FILE *fp I file pointer
|
||||
* return : status (-2: end of file, -1...10: same as above)
|
||||
|
@ -1819,7 +1819,7 @@ unsigned int tickget(void)
|
||||
|
||||
/* sleep ms --------------------------------------------------------------------
|
||||
* sleep ms
|
||||
* args : int ms I miliseconds to sleep (<0:no sleep)
|
||||
* args : int ms I milliseconds to sleep (<0:no sleep)
|
||||
* return : none
|
||||
*-----------------------------------------------------------------------------*/
|
||||
void sleepms(int ms)
|
||||
@ -1884,7 +1884,7 @@ double dms2deg(const double *dms)
|
||||
}
|
||||
|
||||
|
||||
/* transform ecef to geodetic postion ------------------------------------------
|
||||
/* transform ecef to geodetic position ------------------------------------------
|
||||
* transform ecef position to geodetic position
|
||||
* args : double *r I ecef position {x,y,z} (m)
|
||||
* double *pos O geodetic position {lat,lon,h} (rad,m)
|
||||
@ -1926,8 +1926,8 @@ void pos2ecef(const double *pos, double *r)
|
||||
}
|
||||
|
||||
|
||||
/* ecef to local coordinate transfromation matrix ------------------------------
|
||||
* compute ecef to local coordinate transfromation matrix
|
||||
/* ecef to local coordinate transformation matrix ------------------------------
|
||||
* compute ecef to local coordinate transformation matrix
|
||||
* args : double *pos I geodetic position {lat,lon} (rad)
|
||||
* double *E O ecef to local coord transformation matrix (3x3)
|
||||
* return : none
|
||||
@ -2223,7 +2223,7 @@ void eci2ecef(gtime_t tutc, const double *erpv, double *U, double *gmst)
|
||||
matmul("NN", 3, 3, 3, 1.0, R1, R2, 0.0, R);
|
||||
matmul("NN", 3, 3, 3, 1.0, R, R3, 0.0, N); /* N=Rx(-eps)*Rz(-dspi)*Rx(eps) */
|
||||
|
||||
/* greenwich aparent sidereal time (rad) */
|
||||
/* greenwich apparent sidereal time (rad) */
|
||||
gmst_ = utc2gmst(tutc_, erpv[2]);
|
||||
gast = gmst_ + dpsi * cos(eps);
|
||||
gast += (0.00264 * sin(f[4]) + 0.000063 * sin(2.0 * f[4])) * AS2R;
|
||||
|
@ -599,7 +599,7 @@ void udpos(rtk_t *rtk, double tt)
|
||||
for (i = 0; i < 3; i++) initx_rtk(rtk, rtk->sol.rr[i], VAR_POS, i);
|
||||
return;
|
||||
}
|
||||
/* check variance of estimated postion */
|
||||
/* check variance of estimated position */
|
||||
for (i = 0; i < 3; i++)
|
||||
{
|
||||
var += rtk->P[i + i * rtk->nx];
|
||||
|
@ -150,7 +150,7 @@ void covtosol(const double *P, sol_t *sol)
|
||||
}
|
||||
|
||||
|
||||
/* decode nmea gprmc: recommended minumum data for gps -----------------------*/
|
||||
/* decode nmea gprmc: recommended minimum data for gps -----------------------*/
|
||||
int decode_nmearmc(char **val, int n, sol_t *sol)
|
||||
{
|
||||
double tod = 0.0, lat = 0.0, lon = 0.0, vel = 0.0, dir = 0.0, date = 0.0, ang = 0.0, ep[6];
|
||||
@ -219,7 +219,7 @@ int decode_nmearmc(char **val, int n, sol_t *sol)
|
||||
sol->stat = mode == 'D' ? SOLQ_DGPS : SOLQ_SINGLE;
|
||||
sol->ns = 0;
|
||||
|
||||
sol->type = 0; /* postion type = xyz */
|
||||
sol->type = 0; /* position type = xyz */
|
||||
|
||||
trace(5, "decode_nmearmc: %s rr=%.3f %.3f %.3f stat=%d ns=%d vel=%.2f dir=%.0f ang=%.0f mew=%c mode=%c\n",
|
||||
time_str(sol->time, 0), sol->rr[0], sol->rr[1], sol->rr[2], sol->stat, sol->ns,
|
||||
@ -310,7 +310,7 @@ int decode_nmeagga(char **val, int n, sol_t *sol)
|
||||
sol->stat = 0 <= solq && solq <= 8 ? solq_nmea[solq] : SOLQ_NONE;
|
||||
sol->ns = nrcv;
|
||||
|
||||
sol->type = 0; /* postion type = xyz */
|
||||
sol->type = 0; /* position type = xyz */
|
||||
|
||||
trace(5, "decode_nmeagga: %s rr=%.3f %.3f %.3f stat=%d ns=%d hdop=%.1f ua=%c um=%c\n",
|
||||
time_str(sol->time, 0), sol->rr[0], sol->rr[1], sol->rr[2], sol->stat, sol->ns,
|
||||
@ -453,7 +453,7 @@ int decode_solxyz(char *buff, const solopt_t *opt, sol_t *sol)
|
||||
if (i < n) sol->age = (float)val[i++];
|
||||
if (i < n) sol->ratio = (float)val[i];
|
||||
|
||||
sol->type = 0; /* postion type = xyz */
|
||||
sol->type = 0; /* position type = xyz */
|
||||
|
||||
if (MAXSOLQ < sol->stat) sol->stat = SOLQ_NONE;
|
||||
return 1;
|
||||
@ -512,7 +512,7 @@ int decode_solllh(char *buff, const solopt_t *opt, sol_t *sol)
|
||||
if (i < n) sol->age = (float)val[i++];
|
||||
if (i < n) sol->ratio = (float)val[i];
|
||||
|
||||
sol->type = 0; /* postion type = xyz */
|
||||
sol->type = 0; /* position type = xyz */
|
||||
|
||||
if (MAXSOLQ < sol->stat) sol->stat = SOLQ_NONE;
|
||||
return 1;
|
||||
@ -558,7 +558,7 @@ int decode_solenu(char *buff, const solopt_t *opt, sol_t *sol)
|
||||
if (i < n) sol->age = (float)val[i++];
|
||||
if (i < n) sol->ratio = (float)val[i];
|
||||
|
||||
sol->type = 1; /* postion type = enu */
|
||||
sol->type = 1; /* position type = enu */
|
||||
|
||||
if (MAXSOLQ < sol->stat) sol->stat = SOLQ_NONE;
|
||||
return 1;
|
||||
@ -1798,7 +1798,7 @@ int outsols(unsigned char *buff, const sol_t *sol, const double *rb,
|
||||
|
||||
|
||||
/* output solution extended ----------------------------------------------------
|
||||
* output solution exteneded infomation
|
||||
* output solution exteneded information
|
||||
* args : unsigned char *buff IO output buffer
|
||||
* sol_t *sol I solution
|
||||
* ssat_t *ssat I satellite status
|
||||
@ -1892,7 +1892,7 @@ void outsol(FILE *fp, const sol_t *sol, const double *rb,
|
||||
|
||||
|
||||
/* output solution extended ----------------------------------------------------
|
||||
* output solution exteneded infomation to file
|
||||
* output solution exteneded information to file
|
||||
* args : FILE *fp I output file pointer
|
||||
* sol_t *sol I solution
|
||||
* ssat_t *ssat I satellite status
|
||||
|
@ -1916,7 +1916,7 @@ void strunlock(stream_t *stream) { rtk_unlock(&stream->lock); }
|
||||
/* read stream -----------------------------------------------------------------
|
||||
* read data from stream (unblocked)
|
||||
* args : stream_t *stream I stream
|
||||
* unsinged char *buff O data buffer
|
||||
* unsigned char *buff O data buffer
|
||||
* int n I maximum data length
|
||||
* return : read data length
|
||||
* notes : if no data, return immediately with no data
|
||||
@ -1978,7 +1978,7 @@ int strread(stream_t *stream, unsigned char *buff, int n)
|
||||
/* write stream ----------------------------------------------------------------
|
||||
* write data to stream (unblocked)
|
||||
* args : stream_t *stream I stream
|
||||
* unsinged char *buff I data buffer
|
||||
* unsigned char *buff I data buffer
|
||||
* int n I data length
|
||||
* return : status (0:error, 1:ok)
|
||||
* notes : write data to buffer and return immediately
|
||||
|
@ -55,7 +55,7 @@ RtlTcpSignalSource::RtlTcpSignalSource(ConfigurationInterface* configuration,
|
||||
dump_filename_ = configuration->property(role + ".dump_filename",
|
||||
default_dump_file);
|
||||
|
||||
// rtl_tcp PARAMTERS
|
||||
// rtl_tcp PARAMETERS
|
||||
std::string default_address = "127.0.0.1";
|
||||
short default_port = 1234;
|
||||
AGC_enabled_ = configuration->property(role + ".AGC_enabled", true);
|
||||
|
@ -121,7 +121,7 @@ unpack_2bit_samples::unpack_2bit_samples(bool big_endian_bytes,
|
||||
bool big_endian_system = systemIsBigEndian();
|
||||
|
||||
// Only swap the item bytes if the item size > 1 byte and the system
|
||||
// endianess is not the same as the item endianness:
|
||||
// endianness is not the same as the item endianness:
|
||||
swap_endian_items_ = (item_size_ > 1) &&
|
||||
(big_endian_system != big_endian_items);
|
||||
|
||||
|
@ -320,7 +320,7 @@ int galileo_e1b_telemetry_decoder_cc::general_work(int noutput_items __attribute
|
||||
d_stat = 1; // enter into frame pre-detection status
|
||||
}
|
||||
}
|
||||
else if (d_stat == 1) // posible preamble lock
|
||||
else if (d_stat == 1) // possible preamble lock
|
||||
{
|
||||
if (abs(corr_value) >= d_symbols_per_preamble)
|
||||
{
|
||||
|
@ -338,7 +338,7 @@ int galileo_e5a_telemetry_decoder_cc::general_work(int noutput_items __attribute
|
||||
d_stat = 1; // enter into frame pre-detection status
|
||||
}
|
||||
}
|
||||
else if ((d_stat == 1) && new_symbol) // posible preamble lock
|
||||
else if ((d_stat == 1) && new_symbol) // possible preamble lock
|
||||
{
|
||||
if (abs(corr_value) >= GALILEO_FNAV_PREAMBLE_LENGTH_BITS)
|
||||
{
|
||||
|
@ -271,7 +271,7 @@ int glonass_l1_ca_telemetry_decoder_cc::general_work(int noutput_items __attribu
|
||||
d_preamble_time_samples = d_symbol_history.at(0).Tracking_sample_counter; // record the preamble sample stamp
|
||||
}
|
||||
}
|
||||
else if (d_stat == 1) // posible preamble lock
|
||||
else if (d_stat == 1) // possible preamble lock
|
||||
{
|
||||
if (abs(corr_value) >= d_symbols_per_preamble)
|
||||
{
|
||||
|
@ -715,7 +715,7 @@ int galileo_e1_dll_pll_veml_tracking_cc::general_work(int noutput_items __attrib
|
||||
double code_error_filt_secs;
|
||||
code_error_filt_secs = (Galileo_E1_CODE_PERIOD * d_code_error_filt_chips) / Galileo_E1_CODE_CHIP_RATE_HZ; // [seconds]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_chip_seconds = 1.0 / d_code_freq_chips;
|
||||
@ -841,7 +841,7 @@ int galileo_e1_dll_pll_veml_tracking_cc::general_work(int noutput_items __attrib
|
||||
d_rem_carr_phase_rad = d_rem_carr_phase_rad + GALILEO_TWO_PI * d_carrier_doppler_hz * static_cast<double>(d_current_prn_length_samples) / static_cast<double>(d_fs_in);
|
||||
d_rem_carr_phase_rad = std::fmod(d_rem_carr_phase_rad, GALILEO_TWO_PI);
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_chip_seconds = 1.0 / d_code_freq_chips;
|
||||
@ -921,7 +921,7 @@ int galileo_e1_dll_pll_veml_tracking_cc::general_work(int noutput_items __attrib
|
||||
double code_error_filt_secs;
|
||||
code_error_filt_secs = (Galileo_E1_CODE_PERIOD * d_code_error_filt_chips) / Galileo_E1_CODE_CHIP_RATE_HZ; //[seconds]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_chip_seconds = 1.0 / d_code_freq_chips;
|
||||
|
@ -355,13 +355,13 @@ int Galileo_E1_Tcp_Connector_Tracking_cc::general_work(int noutput_items __attri
|
||||
code_error_filt_secs = (Galileo_E1_CODE_PERIOD * code_error_filt_chips) / Galileo_E1_CODE_CHIP_RATE_HZ; //[seconds]
|
||||
d_acc_code_phase_secs = d_acc_code_phase_secs + code_error_filt_secs;
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
double T_chip_seconds;
|
||||
double T_prn_seconds;
|
||||
double T_prn_samples;
|
||||
double K_blk_samples;
|
||||
// Compute the next buffer lenght based in the new period of the PRN sequence and the code phase error estimation
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
T_chip_seconds = 1 / static_cast<double>(d_code_freq_chips);
|
||||
T_prn_seconds = T_chip_seconds * Galileo_E1_B_CODE_LENGTH_CHIPS;
|
||||
T_prn_samples = T_prn_seconds * static_cast<double>(d_fs_in);
|
||||
|
@ -605,7 +605,7 @@ int glonass_l1_ca_dll_pll_c_aid_tracking_cc::general_work(int noutput_items __at
|
||||
d_code_phase_step_chips,
|
||||
d_correlation_length_samples);
|
||||
|
||||
// ####### coherent intergration extension
|
||||
// ####### coherent integration extension
|
||||
// keep the last symbols
|
||||
d_E_history.push_back(d_correlator_outs[0]); // save early output
|
||||
d_P_history.push_back(d_correlator_outs[1]); // save prompt output
|
||||
@ -720,7 +720,7 @@ int glonass_l1_ca_dll_pll_c_aid_tracking_cc::general_work(int noutput_items __at
|
||||
d_code_error_filt_chips_Ti = d_code_error_filt_chips_s * CURRENT_INTEGRATION_TIME_S;
|
||||
code_error_filt_secs_Ti = d_code_error_filt_chips_Ti / d_code_freq_chips; // [s/Ti]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_chip_seconds = 1.0 / d_code_freq_chips;
|
||||
|
@ -599,7 +599,7 @@ int glonass_l1_ca_dll_pll_c_aid_tracking_sc::general_work(int noutput_items __at
|
||||
d_code_phase_step_chips,
|
||||
d_correlation_length_samples);
|
||||
|
||||
// ####### coherent intergration extension
|
||||
// ####### coherent integration extension
|
||||
// keep the last symbols
|
||||
d_E_history.push_back(d_correlator_outs_16sc[0]); // save early output
|
||||
d_P_history.push_back(d_correlator_outs_16sc[1]); // save prompt output
|
||||
@ -712,7 +712,7 @@ int glonass_l1_ca_dll_pll_c_aid_tracking_sc::general_work(int noutput_items __at
|
||||
d_code_error_filt_chips_Ti = d_code_error_filt_chips_s * CURRENT_INTEGRATION_TIME_S;
|
||||
code_error_filt_secs_Ti = d_code_error_filt_chips_Ti / d_code_freq_chips; // [s/Ti]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_chip_seconds = 1.0 / d_code_freq_chips;
|
||||
|
@ -584,7 +584,7 @@ int Glonass_L1_Ca_Dll_Pll_Tracking_cc::general_work(int noutput_items __attribut
|
||||
double code_error_filt_secs = (T_prn_seconds * code_error_filt_chips * T_chip_seconds); //[seconds]
|
||||
//double code_error_filt_secs = (GPS_L1_CA_CODE_PERIOD * code_error_filt_chips) / GLONASS_L1_CA_CODE_RATE_HZ; // [seconds]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
//double T_chip_seconds = 1.0 / static_cast<double>(d_code_freq_chips);
|
||||
|
@ -587,7 +587,7 @@ int gps_l1_ca_dll_pll_c_aid_tracking_cc::general_work(int noutput_items __attrib
|
||||
d_code_phase_step_chips,
|
||||
d_correlation_length_samples);
|
||||
|
||||
// ####### coherent intergration extension
|
||||
// ####### coherent integration extension
|
||||
// keep the last symbols
|
||||
d_E_history.push_back(d_correlator_outs[0]); // save early output
|
||||
d_P_history.push_back(d_correlator_outs[1]); // save prompt output
|
||||
@ -701,7 +701,7 @@ int gps_l1_ca_dll_pll_c_aid_tracking_cc::general_work(int noutput_items __attrib
|
||||
d_code_error_filt_chips_Ti = d_code_error_filt_chips_s * CURRENT_INTEGRATION_TIME_S;
|
||||
code_error_filt_secs_Ti = d_code_error_filt_chips_Ti / d_code_freq_chips; // [s/Ti]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_chip_seconds = 1.0 / d_code_freq_chips;
|
||||
|
@ -387,7 +387,7 @@ int gps_l1_ca_dll_pll_c_aid_tracking_fpga_sc::general_work(
|
||||
d_rem_code_phase_chips, d_code_phase_step_chips,
|
||||
d_correlation_length_samples);
|
||||
|
||||
// ####### coherent intergration extension
|
||||
// ####### coherent integration extension
|
||||
// keep the last symbols
|
||||
d_E_history.push_back(d_correlator_outs_16sc[0]); // save early output
|
||||
d_P_history.push_back(d_correlator_outs_16sc[1]); // save prompt output
|
||||
@ -517,7 +517,7 @@ int gps_l1_ca_dll_pll_c_aid_tracking_fpga_sc::general_work(
|
||||
d_code_error_filt_chips_Ti = d_code_error_filt_chips_s * CURRENT_INTEGRATION_TIME_S;
|
||||
code_error_filt_secs_Ti = d_code_error_filt_chips_Ti / d_code_freq_chips; // [s/Ti]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_chip_seconds = 1.0 / d_code_freq_chips;
|
||||
|
@ -590,7 +590,7 @@ int gps_l1_ca_dll_pll_c_aid_tracking_sc::general_work(int noutput_items __attrib
|
||||
d_code_phase_step_chips,
|
||||
d_correlation_length_samples);
|
||||
|
||||
// ####### coherent intergration extension
|
||||
// ####### coherent integration extension
|
||||
// keep the last symbols
|
||||
d_E_history.push_back(d_correlator_outs_16sc[0]); // save early output
|
||||
d_P_history.push_back(d_correlator_outs_16sc[1]); // save prompt output
|
||||
@ -703,7 +703,7 @@ int gps_l1_ca_dll_pll_c_aid_tracking_sc::general_work(int noutput_items __attrib
|
||||
d_code_error_filt_chips_Ti = d_code_error_filt_chips_s * CURRENT_INTEGRATION_TIME_S;
|
||||
code_error_filt_secs_Ti = d_code_error_filt_chips_Ti / d_code_freq_chips; // [s/Ti]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_chip_seconds = 1.0 / d_code_freq_chips;
|
||||
|
@ -579,7 +579,7 @@ int Gps_L1_Ca_Dll_Pll_Tracking_cc::general_work(int noutput_items __attribute__(
|
||||
double code_error_filt_secs = (T_prn_seconds * code_error_filt_chips * T_chip_seconds); //[seconds]
|
||||
//double code_error_filt_secs = (GPS_L1_CA_CODE_PERIOD * code_error_filt_chips) / GPS_L1_CA_CODE_RATE_HZ; // [seconds]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
//double T_chip_seconds = 1.0 / static_cast<double>(d_code_freq_chips);
|
||||
|
@ -368,7 +368,7 @@ int Gps_L1_Ca_Dll_Pll_Tracking_GPU_cc::general_work(int noutput_items __attribut
|
||||
// TODO: PLL carrier aid to DLL is disabled. Re-enable it and measure performance
|
||||
dll_code_error_secs_Ti = -code_error_filt_secs_Ti + d_pll_to_dll_assist_secs_Ti;
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
double T_chip_seconds;
|
||||
double T_prn_seconds;
|
||||
|
@ -333,7 +333,7 @@ int Gps_L1_Ca_Tcp_Connector_Tracking_cc::general_work(int noutput_items __attrib
|
||||
d_sample_counter_seconds = d_sample_counter_seconds + (static_cast<double>(samples_offset) / static_cast<double>(d_fs_in));
|
||||
d_sample_counter = d_sample_counter + samples_offset; //count for the processed samples
|
||||
d_pull_in = false;
|
||||
consume_each(samples_offset); //shift input to perform alignement with local replica
|
||||
consume_each(samples_offset); //shift input to perform alignment with local replica
|
||||
return 1;
|
||||
}
|
||||
|
||||
|
@ -579,7 +579,7 @@ int gps_l2_m_dll_pll_tracking_cc::general_work(int noutput_items __attribute__((
|
||||
double code_error_filt_secs = (T_prn_seconds * code_error_filt_chips * T_chip_seconds); //[seconds]
|
||||
//double code_error_filt_secs = (GPS_L2_M_PERIOD * code_error_filt_chips) / GPS_L2_M_CODE_RATE_HZ; //[seconds]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_prn_samples = T_prn_seconds * static_cast<double>(d_fs_in);
|
||||
|
@ -580,7 +580,7 @@ int gps_l5i_dll_pll_tracking_cc::general_work(int noutput_items __attribute__((u
|
||||
double code_error_filt_secs = (T_prn_seconds * code_error_filt_chips * T_chip_seconds); //[seconds]
|
||||
//double code_error_filt_secs = (GPS_L5i_PERIOD * code_error_filt_chips) / GPS_L5i_CODE_RATE_HZ; //[seconds]
|
||||
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT #######################
|
||||
// ################## CARRIER AND CODE NCO BUFFER ALIGNMENT #######################
|
||||
// keep alignment parameters for the next input buffer
|
||||
// Compute the next buffer length based in the new period of the PRN sequence and the code phase error estimation
|
||||
double T_prn_samples = T_prn_seconds * static_cast<double>(d_fs_in);
|
||||
|
@ -136,7 +136,7 @@ bool fpga_multicorrelator_8sc::Carrier_wipeoff_multicorrelator_resampler(
|
||||
nb = read(d_device_descriptor, &irq_count, sizeof(irq_count));
|
||||
if (nb != sizeof(irq_count))
|
||||
{
|
||||
printf("Tracking_module Read failed to retrive 4 bytes!\n");
|
||||
printf("Tracking_module Read failed to retrieve 4 bytes!\n");
|
||||
printf("Tracking_module Interrupt number %d\n", irq_count);
|
||||
}
|
||||
|
||||
|
@ -109,7 +109,7 @@ public:
|
||||
return running_;
|
||||
}
|
||||
/*!
|
||||
* \brief Sends a GNURadio asyncronous message from telemetry to PVT
|
||||
* \brief Sends a GNURadio asynchronous message from telemetry to PVT
|
||||
*
|
||||
* It is used to assist the receiver with external ephemeris data
|
||||
*/
|
||||
|
@ -42,7 +42,7 @@ Galileo_Ephemeris::Galileo_Ephemeris()
|
||||
M0_1 = 0; // Mean anomaly at reference time [semi-circles]
|
||||
delta_n_3 = 0; // Mean motion difference from computed value [semi-circles/sec]
|
||||
e_1 = 0; // Eccentricity
|
||||
A_1 = 0; // Square root of the semi-major axis [metres^1/2]
|
||||
A_1 = 0; // Square root of the semi-major axis [meters^1/2]
|
||||
OMEGA_0_2 = 0; // Longitude of ascending node of orbital plane at weekly epoch [semi-circles]
|
||||
i_0_2 = 0; // Inclination angle at reference time [semi-circles]
|
||||
omega_2 = 0; // Argument of perigee [semi-circles]
|
||||
|
@ -54,7 +54,7 @@ public:
|
||||
double M0_1; //!< Mean anomaly at reference time [semi-circles]
|
||||
double delta_n_3; //!< Mean motion difference from computed value [semi-circles/sec]
|
||||
double e_1; //!< Eccentricity
|
||||
double A_1; //!< Square root of the semi-major axis [metres^1/2]
|
||||
double A_1; //!< Square root of the semi-major axis [meters^1/2]
|
||||
double OMEGA_0_2; //!< Longitude of ascending node of orbital plane at weekly epoch [semi-circles]
|
||||
double i_0_2; //!< Inclination angle at reference time [semi-circles]
|
||||
double omega_2; //!< Argument of perigee [semi-circles]
|
||||
|
@ -604,7 +604,7 @@ Galileo_Ephemeris Galileo_Fnav_Message::get_ephemeris()
|
||||
ephemeris.M0_1 = FNAV_M0_2; // Mean anomaly at reference time [semi-circles]
|
||||
ephemeris.delta_n_3 = FNAV_deltan_3; // Mean motion difference from computed value [semi-circles/sec]
|
||||
ephemeris.e_1 = FNAV_e_2; // Eccentricity
|
||||
ephemeris.A_1 = FNAV_a12_2; // Square root of the semi-major axis [metres^1/2]
|
||||
ephemeris.A_1 = FNAV_a12_2; // Square root of the semi-major axis [meters^1/2]
|
||||
ephemeris.OMEGA_0_2 = FNAV_omega0_2; // Longitude of ascending node of orbital plane at weekly epoch [semi-circles]
|
||||
ephemeris.i_0_2 = FNAV_i0_3; // Inclination angle at reference time [semi-circles]
|
||||
ephemeris.omega_2 = FNAV_w_3; // Argument of perigee [semi-circles]
|
||||
|
@ -530,7 +530,7 @@ Galileo_Ephemeris Galileo_Navigation_Message::get_ephemeris()
|
||||
ephemeris.M0_1 = M0_1; // Mean anomaly at reference time [semi-circles]
|
||||
ephemeris.delta_n_3 = delta_n_3; // Mean motion difference from computed value [semi-circles/sec]
|
||||
ephemeris.e_1 = e_1; // Eccentricity
|
||||
ephemeris.A_1 = A_1; // Square root of the semi-major axis [metres^1/2]
|
||||
ephemeris.A_1 = A_1; // Square root of the semi-major axis [meters^1/2]
|
||||
ephemeris.OMEGA_0_2 = OMEGA_0_2; // Longitude of ascending node of orbital plane at weekly epoch [semi-circles]
|
||||
ephemeris.i_0_2 = i_0_2; // Inclination angle at reference time [semi-circles]
|
||||
ephemeris.omega_2 = omega_2; // Argument of perigee [semi-circles]
|
||||
|
@ -97,7 +97,7 @@ public:
|
||||
double t0e_1; //!< Ephemeris reference time [s]
|
||||
double M0_1; //!< Mean anomaly at reference time [semi-circles]
|
||||
double e_1; //!< Eccentricity
|
||||
double A_1; //!< Square root of the semi-major axis [metres^1/2]
|
||||
double A_1; //!< Square root of the semi-major axis [meters^1/2]
|
||||
|
||||
/*Word type 2: Ephemeris (2/4)*/
|
||||
int IOD_nav_2; //!< IOD_nav page 2
|
||||
|
@ -559,7 +559,7 @@ std::string Gnss_Satellite::what_block(const std::string& system_, unsigned int
|
||||
block_ = std::string("IOV-FM4**"); // Galileo In-Orbit Validation (IOV) satellite FM4 (Flight Model 4) / GSAT0104, launched on October 12, 2012. Payload power problem beginning May 27, 2014 led to permanent loss of E5 and E6 transmissions, E1 transmission restored. UNAVAILABLE FROM 2014-05-27 UNTIL FURTHER NOTICE
|
||||
break;
|
||||
case 21:
|
||||
block_ = std::string("FOC-FM15"); // Galileo Full Operational Capability (FOC) satellite FM15 / GSAT0215, launched on Dec. 12, 2017. UNDER COMMISIONING.
|
||||
block_ = std::string("FOC-FM15"); // Galileo Full Operational Capability (FOC) satellite FM15 / GSAT0215, launched on Dec. 12, 2017. UNDER COMMISSIONING.
|
||||
break;
|
||||
case 22:
|
||||
block_ = std::string("FOC-FM4**"); // Galileo Full Operational Capability (FOC) satellite FM4 / GSAT0204, launched on March 27, 2015. REMOVED FROM ACTIVE SERVICE ON 2017-12-08 UNTIL FURTHER NOTICE FOR CONSTELLATION MANAGEMENT PURPOSES.
|
||||
@ -568,19 +568,19 @@ std::string Gnss_Satellite::what_block(const std::string& system_, unsigned int
|
||||
block_ = std::string("FOC-FM5"); // Galileo Full Operational Capability (FOC) satellite FM5 / GSAT0205, launched on Sept. 11, 2015.
|
||||
break;
|
||||
case 25:
|
||||
block_ = std::string("FOC-FM16"); // Galileo Full Operational Capability (FOC) satellite FM16 / GSAT0216, launched on Dec. 12, 2017. UNDER COMMISIONING.
|
||||
block_ = std::string("FOC-FM16"); // Galileo Full Operational Capability (FOC) satellite FM16 / GSAT0216, launched on Dec. 12, 2017. UNDER COMMISSIONING.
|
||||
break;
|
||||
case 26:
|
||||
block_ = std::string("FOC-FM3"); // Galileo Full Operational Capability (FOC) satellite FM3 / GSAT0203, launched on March 27, 2015.
|
||||
break;
|
||||
case 27:
|
||||
block_ = std::string("FOC-FM17"); // Galileo Full Operational Capability (FOC) satellite FM17 / GSAT0217, launched on Dec. 12, 2017. UNDER COMMISIONING.
|
||||
block_ = std::string("FOC-FM17"); // Galileo Full Operational Capability (FOC) satellite FM17 / GSAT0217, launched on Dec. 12, 2017. UNDER COMMISSIONING.
|
||||
break;
|
||||
case 30:
|
||||
block_ = std::string("FOC-FM6"); // Galileo Full Operational Capability (FOC) satellite FM6 / GSAT0206, launched on Sept. 11, 2015.
|
||||
break;
|
||||
case 31:
|
||||
block_ = std::string("FOC-FM18"); // Galileo Full Operational Capability (FOC) satellite FM18 / GSAT0218, launched on Dec. 12, 2017. UNDER COMMISIONING.
|
||||
block_ = std::string("FOC-FM18"); // Galileo Full Operational Capability (FOC) satellite FM18 / GSAT0218, launched on Dec. 12, 2017. UNDER COMMISSIONING.
|
||||
break;
|
||||
default:
|
||||
block_ = std::string("Unknown(Simulated)");
|
||||
|
@ -67,8 +67,8 @@ public:
|
||||
double d_TOW;
|
||||
bool b_flag_ephemeris_1;
|
||||
bool b_flag_ephemeris_2;
|
||||
bool b_flag_iono_valid; //!< If set, it indicates that the ionospheric parameters are filled and are not yet readed by the get_iono
|
||||
bool b_flag_utc_valid; //!< If set, it indicates that the utc parameters are filled and are not yet readed by the get_utc_model
|
||||
bool b_flag_iono_valid; //!< If set, it indicates that the ionospheric parameters are filled and are not yet read by the get_iono
|
||||
bool b_flag_utc_valid; //!< If set, it indicates that the utc parameters are filled and are not yet read by the get_utc_model
|
||||
|
||||
std::map<int, std::string> satelliteBlock; //!< Map that stores to which block the PRN belongs http://www.navcen.uscg.gov/?Do=constellationStatus
|
||||
|
||||
|
@ -5265,7 +5265,7 @@ int Rtcm::set_DF401(const Gnss_Synchro& gnss_synchro)
|
||||
|
||||
phrng_m = (gnss_synchro.Carrier_phase_rads / GPS_TWO_PI) * lambda - rough_range_m;
|
||||
|
||||
/* Substract phase - pseudorange integer cycle offset */
|
||||
/* Subtract phase - pseudorange integer cycle offset */
|
||||
/* TODO: check LLI! */
|
||||
double cp = gnss_synchro.Carrier_phase_rads / GPS_TWO_PI; // ?
|
||||
if (std::fabs(phrng_m - cp) > 1171.0)
|
||||
@ -5460,7 +5460,7 @@ int Rtcm::set_DF406(const Gnss_Synchro& gnss_synchro)
|
||||
}
|
||||
phrng_m = (gnss_synchro.Carrier_phase_rads / GPS_TWO_PI) * lambda - rough_range_m;
|
||||
|
||||
/* Substract phase - pseudorange integer cycle offset */
|
||||
/* Subtract phase - pseudorange integer cycle offset */
|
||||
/* TODO: check LLI! */
|
||||
double cp = gnss_synchro.Carrier_phase_rads / GPS_TWO_PI; // ?
|
||||
if (std::fabs(phrng_m - cp) > 1171.0)
|
||||
|
@ -209,7 +209,7 @@ if(ENABLE_UNIT_TESTING_EXTRA OR ENABLE_SYSTEM_TESTING_EXTRA OR ENABLE_FPGA)
|
||||
################################################################################
|
||||
find_package(GPSTK)
|
||||
if(NOT GPSTK_FOUND OR ENABLE_OWN_GPSTK)
|
||||
message(STATUS "GPSTk v${GNSSSDR_GPSTK_LOCAL_VERSION} will be automatically donwloaded and built when doing 'make'.")
|
||||
message(STATUS "GPSTk v${GNSSSDR_GPSTK_LOCAL_VERSION} will be automatically downloaded and built when doing 'make'.")
|
||||
if(NOT ENABLE_FPGA)
|
||||
if(CMAKE_VERSION VERSION_LESS 3.2)
|
||||
ExternalProject_Add(
|
||||
|
@ -110,7 +110,7 @@ private:
|
||||
static std::string m_sGNUPlotFileName;
|
||||
///\brief gnuplot path
|
||||
static std::string m_sGNUPlotPath;
|
||||
///\brief standart terminal, used by showonscreen
|
||||
///\brief standard terminal, used by showonscreen
|
||||
static std::string terminal_std;
|
||||
|
||||
//----------------------------------------------------------------------------------
|
||||
@ -174,7 +174,7 @@ public:
|
||||
static bool set_GNUPlotPath(const std::string &path);
|
||||
|
||||
// ----------------------------------------------------------------------------
|
||||
/// optional: set standart terminal, used by showonscreen
|
||||
/// optional: set standard terminal, used by showonscreen
|
||||
/// defaults: Windows - win, Linux - x11, Mac - aqua
|
||||
///
|
||||
/// \param type --> the terminal type
|
||||
@ -260,7 +260,7 @@ public:
|
||||
/// interpolation and approximation of data, arguments:
|
||||
/// csplines, bezier, acsplines (for data values > 0), sbezier, unique, frequency
|
||||
/// (works only with plot_x, plot_xy, plotfile_x, plotfile_xy
|
||||
/// (if smooth is set, set_style has no effekt on data plotting)
|
||||
/// (if smooth is set, set_style has no effect on data plotting)
|
||||
Gnuplot &set_smooth(const std::string &stylestr = "csplines");
|
||||
|
||||
// ----------------------------------------------------------------------
|
||||
@ -610,14 +610,14 @@ public:
|
||||
|
||||
/// plot an equation supplied as a std::string y=f(x), write only the function f(x) not y=
|
||||
/// the independent variable has to be x
|
||||
/// binary operators: ** exponentiation, * multiply, / divide, + add, - substract, % modulo
|
||||
/// binary operators: ** exponentiation, * multiply, / divide, + add, - subtract, % modulo
|
||||
/// unary operators: - minus, ! factorial
|
||||
/// elementary functions: rand(x), abs(x), sgn(x), ceil(x), floor(x), int(x), imag(x), real(x), arg(x),
|
||||
/// sqrt(x), exp(x), log(x), log10(x), sin(x), cos(x), tan(x), asin(x), acos(x), atan(x), atan2(y,x),
|
||||
/// sinh(x), cosh(x), tanh(x), asinh(x), acosh(x), atanh(x)
|
||||
/// special functions: erf(x), erfc(x), inverf(x), gamma(x), igamma(a,x), lgamma(x), ibeta(p,q,x),
|
||||
/// besj0(x), besj1(x), besy0(x), besy1(x), lambertw(x)
|
||||
/// statistical fuctions: norm(x), invnorm(x)
|
||||
/// statistical functions: norm(x), invnorm(x)
|
||||
Gnuplot &plot_equation(const std::string &equation, const std::string &title = "");
|
||||
|
||||
/// plot an equation supplied as a std::string z=f(x,y), write only the function f(x,y) not z=
|
||||
@ -1014,7 +1014,7 @@ bool Gnuplot::set_GNUPlotPath(const std::string &path)
|
||||
|
||||
//------------------------------------------------------------------------------
|
||||
//
|
||||
// define static member function: set standart terminal, used by showonscreen
|
||||
// define static member function: set standard terminal, used by showonscreen
|
||||
// defaults: Windows - win, Linux - x11, Mac - aqua
|
||||
//
|
||||
void Gnuplot::set_terminal_std(const std::string &type)
|
||||
@ -1106,7 +1106,7 @@ Gnuplot &Gnuplot::reset_plot()
|
||||
|
||||
//------------------------------------------------------------------------------
|
||||
//
|
||||
// resets a gnuplot session and sets all varibles to default
|
||||
// resets a gnuplot session and sets all variables to default
|
||||
//
|
||||
Gnuplot &Gnuplot::reset_all()
|
||||
{
|
||||
|
@ -292,7 +292,7 @@ TEST(RtcmTest, MT1020)
|
||||
gnav_ephemeris.d_t_k = 7560;
|
||||
// Glonass signed values
|
||||
gnav_ephemeris.d_VXn = -0.490900039672852;
|
||||
// Bit distribution per fields dependant on other factors
|
||||
// Bit distribution per fields dependent on other factors
|
||||
gnav_ephemeris.d_t_b = 8100;
|
||||
// Binary flag representation
|
||||
gnav_ephemeris.d_P_3 = 1;
|
||||
|
@ -154,7 +154,7 @@ void wait_message()
|
||||
{
|
||||
int message;
|
||||
channel_internal_queue.wait_and_pop(message);
|
||||
//std::cout<<"Acq mesage rx="<<message<<std::endl;
|
||||
//std::cout<<"Acq message rx="<<message<<std::endl;
|
||||
switch (message)
|
||||
{
|
||||
case 1: // Positive acq
|
||||
|
Loading…
Reference in New Issue
Block a user