mirror of
				https://github.com/gnss-sdr/gnss-sdr
				synced 2025-10-31 15:23:04 +00:00 
			
		
		
		
	Code cleaning and improving documentation
git-svn-id: https://svn.code.sf.net/p/gnss-sdr/code/trunk@455 64b25241-fba3-4117-9849-534c7e92360d
This commit is contained in:
		| @@ -1,10 +1,8 @@ | ||||
| /*! | ||||
|  * \file galileo_e1_pvt.h | ||||
|  * \brief Interface of an adapter of a GALILEO E1 PVT solver block to a | ||||
|  * PvtInterface | ||||
|  * Position Velocity and Time | ||||
|  * \author Javier Arribas, 2011. jarribas(at)cttc.es | ||||
|  * | ||||
|  * PvtInterface. | ||||
|  * \author Javier Arribas, 2013. jarribas(at)cttc.es | ||||
|  * | ||||
|  * ------------------------------------------------------------------------- | ||||
|  * | ||||
| @@ -43,7 +41,7 @@ | ||||
| class ConfigurationInterface; | ||||
|  | ||||
| /*! | ||||
|  * \brief This class implements a PvtInterface for GPS L1 C/A | ||||
|  * \brief This class implements a PvtInterface for Galileo E1 | ||||
|  */ | ||||
| class GalileoE1Pvt : public PvtInterface | ||||
| { | ||||
| @@ -61,7 +59,7 @@ public: | ||||
|         return role_; | ||||
|     } | ||||
|  | ||||
|     //!  Returns "GPS_L1_CA_PVT" | ||||
|     //!  Returns "GALILEO_E1_PVT" | ||||
|     std::string implementation() | ||||
|     { | ||||
|         return "GALILEO_E1_PVT"; | ||||
|   | ||||
| @@ -1,10 +1,11 @@ | ||||
| /*! | ||||
|  * \file galileo_e1_pvt_cc.cc | ||||
|  * \brief Implementation of a Position Velocity and Time computation block for GPS L1 C/A | ||||
|  * \author Javier Arribas, 2011. jarribas(at)cttc.es | ||||
|  * \author Javier Arribas, 2013. jarribas(at)cttc.es | ||||
|  * | ||||
|  * ------------------------------------------------------------------------- | ||||
|  * | ||||
|  * Copyright (C) 2010-2012  (see AUTHORS file for a list of contributors) | ||||
|  * Copyright (C) 2010-2013  (see AUTHORS file for a list of contributors) | ||||
|  * | ||||
|  * GNSS-SDR is a software defined Global Navigation | ||||
|  *          Satellite Systems receiver | ||||
| @@ -226,7 +227,8 @@ int galileo_e1_pvt_cc::general_work (int noutput_items, gr_vector_int &ninput_it | ||||
|                     d_ls_pvt->d_VDOP <<" TDOP = " << d_ls_pvt->d_TDOP << | ||||
|                     " GDOP = " << d_ls_pvt->d_GDOP <<std::endl; | ||||
|                 } | ||||
| //            // MULTIPLEXED FILE RECORDING - Record results to file | ||||
|  | ||||
|             // MULTIPLEXED FILE RECORDING - Record results to file | ||||
|             if(d_dump == true) | ||||
|                 { | ||||
|                     try | ||||
|   | ||||
| @@ -48,13 +48,21 @@ | ||||
| #include "GPS_L1_CA.h" | ||||
| #include "Galileo_E1.h" | ||||
|  | ||||
|  | ||||
| class galileo_e1_pvt_cc; | ||||
|  | ||||
| typedef boost::shared_ptr<galileo_e1_pvt_cc> galileo_e1_pvt_cc_sptr; | ||||
|  | ||||
| galileo_e1_pvt_cc_sptr | ||||
| galileo_e1_make_pvt_cc(unsigned int n_channels, boost::shared_ptr<gr::msg_queue> queue, bool dump, std::string dump_filename, int averaging_depth, bool flag_averaging, int output_rate_ms, int display_rate_ms, bool flag_nmea_tty_port, std::string nmea_dump_filename, std::string nmea_dump_devname); | ||||
| galileo_e1_pvt_cc_sptr galileo_e1_make_pvt_cc(unsigned int n_channels, | ||||
|                                               boost::shared_ptr<gr::msg_queue> queue, | ||||
|                                               bool dump, | ||||
|                                               std::string dump_filename, | ||||
|                                               int averaging_depth, | ||||
|                                               bool flag_averaging, | ||||
|                                               int output_rate_ms, | ||||
|                                               int display_rate_ms, | ||||
|                                               bool flag_nmea_tty_port, | ||||
|                                               std::string nmea_dump_filename, | ||||
|                                               std::string nmea_dump_devname); | ||||
|  | ||||
| /*! | ||||
|  * \brief This class implements a block that computes the PVT solution with Galileo E1 signals | ||||
| @@ -62,9 +70,27 @@ galileo_e1_make_pvt_cc(unsigned int n_channels, boost::shared_ptr<gr::msg_queue> | ||||
| class galileo_e1_pvt_cc : public gr::block | ||||
| { | ||||
| private: | ||||
|     friend galileo_e1_pvt_cc_sptr | ||||
|     galileo_e1_make_pvt_cc(unsigned int nchannels, boost::shared_ptr<gr::msg_queue> queue, bool dump, std::string dump_filename, int averaging_depth, bool flag_averaging, int output_rate_ms, int display_rate_ms, bool flag_nmea_tty_port, std::string nmea_dump_filename, std::string nmea_dump_devname); | ||||
|     galileo_e1_pvt_cc(unsigned int nchannels, boost::shared_ptr<gr::msg_queue> queue, bool dump, std::string dump_filename, int averaging_depth, bool flag_averaging, int output_rate_ms, int display_rate_ms, bool flag_nmea_tty_port, std::string nmea_dump_filename, std::string nmea_dump_devname); | ||||
|     friend galileo_e1_pvt_cc_sptr galileo_e1_make_pvt_cc(unsigned int nchannels, | ||||
|                                                          boost::shared_ptr<gr::msg_queue> queue, | ||||
|                                                          bool dump, | ||||
|                                                          std::string dump_filename, | ||||
|                                                          int averaging_depth, | ||||
|                                                          bool flag_averaging, | ||||
|                                                          int output_rate_ms, | ||||
|                                                          int display_rate_ms, | ||||
|                                                          bool flag_nmea_tty_port, | ||||
|                                                          std::string nmea_dump_filename, | ||||
|                                                          std::string nmea_dump_devname); | ||||
|     galileo_e1_pvt_cc(unsigned int nchannels, | ||||
|                       boost::shared_ptr<gr::msg_queue> queue, | ||||
|                       bool dump, std::string dump_filename, | ||||
|                       int averaging_depth, | ||||
|                       bool flag_averaging, | ||||
|                       int output_rate_ms, | ||||
|                       int display_rate_ms, | ||||
|                       bool flag_nmea_tty_port, | ||||
|                       std::string nmea_dump_filename, | ||||
|                       std::string nmea_dump_devname); | ||||
|     boost::shared_ptr<gr::msg_queue> d_queue; | ||||
|     bool d_dump; | ||||
|     bool b_rinex_header_writen; | ||||
| @@ -81,7 +107,7 @@ private: | ||||
|     Kml_Printer d_kml_dump; | ||||
|     Nmea_Printer *d_nmea_printer; | ||||
|     double d_rx_time; | ||||
|     galileo_e1_ls_pvt *d_ls_pvt;  /*modify PVT/libs/galileo_e1_ls_pvt*/ | ||||
|     galileo_e1_ls_pvt *d_ls_pvt; | ||||
|     bool pseudoranges_pairCompare_min(std::pair<int,Gnss_Synchro> a, std::pair<int,Gnss_Synchro> b); | ||||
|  | ||||
| public: | ||||
|   | ||||
| @@ -184,7 +184,7 @@ int gps_l1_ca_pvt_cc::general_work (int noutput_items, gr_vector_int &ninput_ite | ||||
|     // update SBAS data collections | ||||
|     if (global_sbas_iono_map.size() > 0) | ||||
|         { | ||||
|             // SBAS ionosperic correction is shared for all the GPS satellites. Read always at ID=0 | ||||
|             // SBAS ionospheric correction is shared for all the GPS satellites. Read always at ID=0 | ||||
|             global_sbas_iono_map.read(0, d_ls_pvt->sbas_iono); | ||||
|         } | ||||
|     d_ls_pvt->sbas_sat_corr_map = global_sbas_sat_corr_map.get_map_copy(); | ||||
|   | ||||
| @@ -50,8 +50,17 @@ class gps_l1_ca_pvt_cc; | ||||
|  | ||||
| typedef boost::shared_ptr<gps_l1_ca_pvt_cc> gps_l1_ca_pvt_cc_sptr; | ||||
|  | ||||
| gps_l1_ca_pvt_cc_sptr | ||||
| gps_l1_ca_make_pvt_cc(unsigned int n_channels, boost::shared_ptr<gr::msg_queue> queue, bool dump, std::string dump_filename, int averaging_depth, bool flag_averaging, int output_rate_ms, int display_rate_ms, bool flag_nmea_tty_port, std::string nmea_dump_filename, std::string nmea_dump_devname); | ||||
| gps_l1_ca_pvt_cc_sptr gps_l1_ca_make_pvt_cc(unsigned int n_channels, | ||||
|                                             boost::shared_ptr<gr::msg_queue> queue, | ||||
|                                             bool dump, | ||||
|                                             std::string dump_filename, | ||||
|                                             int averaging_depth, | ||||
|                                             bool flag_averaging, | ||||
|                                             int output_rate_ms, | ||||
|                                             int display_rate_ms, | ||||
|                                             bool flag_nmea_tty_port, | ||||
|                                             std::string nmea_dump_filename, | ||||
|                                             std::string nmea_dump_devname); | ||||
|  | ||||
| /*! | ||||
|  * \brief This class implements a block that computes the PVT solution | ||||
| @@ -59,9 +68,28 @@ gps_l1_ca_make_pvt_cc(unsigned int n_channels, boost::shared_ptr<gr::msg_queue> | ||||
| class gps_l1_ca_pvt_cc : public gr::block | ||||
| { | ||||
| private: | ||||
|     friend gps_l1_ca_pvt_cc_sptr | ||||
|     gps_l1_ca_make_pvt_cc(unsigned int nchannels, boost::shared_ptr<gr::msg_queue> queue, bool dump, std::string dump_filename, int averaging_depth, bool flag_averaging, int output_rate_ms, int display_rate_ms, bool flag_nmea_tty_port, std::string nmea_dump_filename, std::string nmea_dump_devname); | ||||
|     gps_l1_ca_pvt_cc(unsigned int nchannels, boost::shared_ptr<gr::msg_queue> queue, bool dump, std::string dump_filename, int averaging_depth, bool flag_averaging, int output_rate_ms, int display_rate_ms, bool flag_nmea_tty_port, std::string nmea_dump_filename, std::string nmea_dump_devname); | ||||
|     friend gps_l1_ca_pvt_cc_sptr gps_l1_ca_make_pvt_cc(unsigned int nchannels, | ||||
|                                                        boost::shared_ptr<gr::msg_queue> queue, | ||||
|                                                        bool dump, | ||||
|                                                        std::string dump_filename, | ||||
|                                                        int averaging_depth, | ||||
|                                                        bool flag_averaging, | ||||
|                                                        int output_rate_ms, | ||||
|                                                        int display_rate_ms, | ||||
|                                                        bool flag_nmea_tty_port, | ||||
|                                                        std::string nmea_dump_filename, | ||||
|                                                        std::string nmea_dump_devname); | ||||
|     gps_l1_ca_pvt_cc(unsigned int nchannels, | ||||
|                      boost::shared_ptr<gr::msg_queue> queue, | ||||
|                      bool dump, | ||||
|                      std::string dump_filename, | ||||
|                      int averaging_depth, | ||||
|                      bool flag_averaging, | ||||
|                      int output_rate_ms, | ||||
|                      int display_rate_ms, | ||||
|                      bool flag_nmea_tty_port, | ||||
|                      std::string nmea_dump_filename, | ||||
|                      std::string nmea_dump_devname); | ||||
|     boost::shared_ptr<gr::msg_queue> d_queue; | ||||
|     bool d_dump; | ||||
|     bool b_rinex_header_writen; | ||||
|   | ||||
| @@ -3,9 +3,10 @@ | ||||
|  * \brief Implementation of a Least Squares Position, Velocity, and Time | ||||
|  * (PVT) solver, based on K.Borre's Matlab receiver. | ||||
|  * \author Javier Arribas, 2011. jarribas(at)cttc.es | ||||
|  * | ||||
|  * ------------------------------------------------------------------------- | ||||
|  * | ||||
|  * Copyright (C) 2010-2012  (see AUTHORS file for a list of contributors) | ||||
|  * Copyright (C) 2010-2013  (see AUTHORS file for a list of contributors) | ||||
|  * | ||||
|  * GNSS-SDR is a software defined Global Navigation | ||||
|  *          Satellite Systems receiver | ||||
| @@ -30,7 +31,6 @@ | ||||
|  | ||||
| #include <armadillo> | ||||
| #include "galileo_e1_ls_pvt.h" | ||||
|  | ||||
| #include "Galileo_E1.h" | ||||
| #include <glog/log_severity.h> | ||||
| #include <glog/logging.h> | ||||
| @@ -145,16 +145,6 @@ arma::vec galileo_e1_ls_pvt::leastSquarePos(arma::mat satpos, arma::vec obs, arm | ||||
|     omc = arma::zeros(nmbOfSatellites, 1); | ||||
|     az = arma::zeros(1, nmbOfSatellites); | ||||
|     el = arma::zeros(1, nmbOfSatellites); | ||||
|     for (int i = 0; i < nmbOfSatellites; i++) | ||||
|         { | ||||
|             for (int j = 0; j < 4; j++) | ||||
|                 { | ||||
|                     A(i, j) = 0.0; //Armadillo | ||||
|                 } | ||||
|             omc(i, 0) = 0.0; | ||||
|             az(0, i) = 0.0; | ||||
|         } | ||||
|     el = az; | ||||
|     arma::mat X = satpos; | ||||
|     arma::vec Rot_X; | ||||
|     double rho2; | ||||
| @@ -187,10 +177,11 @@ arma::vec galileo_e1_ls_pvt::leastSquarePos(arma::mat satpos, arma::vec obs, arm | ||||
|                             Rot_X = rotateSatellite(traveltime, X.col(i)); //armadillo | ||||
|  | ||||
|                             //--- Find DOA and range of satellites | ||||
|                             topocent(&d_visible_satellites_Az[i], &d_visible_satellites_El[i], | ||||
|                                     &d_visible_satellites_Distance[i], pos.subvec(0,2), Rot_X - pos.subvec(0,2)); | ||||
|                             //[az(i), el(i), dist] = topocent(pos(1:3, :), Rot_X - pos(1:3, :)); | ||||
|  | ||||
|                             topocent(&d_visible_satellites_Az[i], | ||||
|                                      &d_visible_satellites_El[i], | ||||
|                                      &d_visible_satellites_Distance[i], | ||||
|                                      pos.subvec(0,2), | ||||
|                                      Rot_X - pos.subvec(0, 2)); | ||||
|                         } | ||||
|                     //--- Apply the corrections ---------------------------------------- | ||||
|                     omc(i) = (obs(i) - norm(Rot_X - pos.subvec(0, 2), 2) - pos(3) - trop); // Armadillo | ||||
| @@ -217,7 +208,6 @@ arma::vec galileo_e1_ls_pvt::leastSquarePos(arma::mat satpos, arma::vec obs, arm | ||||
|     try | ||||
|     { | ||||
|             //-- compute the Dilution Of Precision values | ||||
|             //arma::mat Q; | ||||
|             d_Q = arma::inv(arma::htrans(A)*A); | ||||
|     } | ||||
|     catch(std::exception& e) | ||||
| @@ -245,8 +235,6 @@ bool galileo_e1_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map | ||||
|     double TX_time_corrected_s; | ||||
|     double SV_clock_bias_s = 0; | ||||
|  | ||||
|     //double GST=0; | ||||
|  | ||||
|     d_flag_averaging = flag_averaging; | ||||
|  | ||||
|     // ******************************************************************************** | ||||
| @@ -277,7 +265,6 @@ bool galileo_e1_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map | ||||
|                     //JAVIER VERSION: | ||||
|                     double Rx_time = galileo_current_time; | ||||
|  | ||||
|  | ||||
|                     //to compute satellite position we need GST = WN+TOW (everything expressed in seconds) | ||||
|                     //double Rx_time = galileo_current_time + Galileo_week_number*sec_in_day*day_in_week; | ||||
|  | ||||
| @@ -298,7 +285,7 @@ bool galileo_e1_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map | ||||
|                     satpos(1,obs_counter) = galileo_ephemeris_iter->second.d_satpos_Y; | ||||
|                     satpos(2,obs_counter) = galileo_ephemeris_iter->second.d_satpos_Z; | ||||
|  | ||||
|                     // 5- fill the observations vector with the corrected pseudorranges | ||||
|                     // 5- fill the observations vector with the corrected pseudoranges | ||||
|                     obs(obs_counter) = gnss_pseudoranges_iter->second.Pseudorange_m + SV_clock_bias_s*GALILEO_C_m_s; | ||||
|                     d_visible_satellites_IDs[valid_obs] = galileo_ephemeris_iter->second.i_satellite_PRN; | ||||
|                     d_visible_satellites_CN0_dB[valid_obs] = gnss_pseudoranges_iter->second.CN0_dB_hz; | ||||
| @@ -310,12 +297,11 @@ bool galileo_e1_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map | ||||
|                     double GST = galileo_ephemeris_iter->second.Galileo_System_Time(Galileo_week_number, galileo_current_time); | ||||
|                     utc = galileo_utc_model.GST_to_UTC_time(GST, Galileo_week_number); | ||||
|                     // get time string gregorian calendar | ||||
|                     //std::cout<<"UTC_raw="<<utc<<std::endl; | ||||
|                     boost::posix_time::time_duration t = boost::posix_time::seconds(utc); | ||||
|                     // 22 August 1999 00:00 last Galileo start GST epoch (ICD sec 5.1.2) | ||||
|                     boost::posix_time::ptime p_time(boost::gregorian::date(1999, 8, 22), t); | ||||
|                     d_position_UTC_time = p_time; | ||||
|                     //std::cout << "Galileo RX time at " << boost::posix_time::to_simple_string(p_time)<<std::endl; | ||||
|                     DLOG(INFO) << "Galileo RX time at " << boost::posix_time::to_simple_string(p_time); | ||||
|                     //end debug | ||||
|  | ||||
|                     // SV ECEF DEBUG OUTPUT | ||||
| @@ -323,59 +309,55 @@ bool galileo_e1_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map | ||||
|                                << " X=" << galileo_ephemeris_iter->second.d_satpos_X | ||||
|                                << " [m] Y=" << galileo_ephemeris_iter->second.d_satpos_Y | ||||
|                                << " [m] Z=" << galileo_ephemeris_iter->second.d_satpos_Z | ||||
|                             << " [m] PR_obs=" << obs(obs_counter) << " [m]" << std::endl; | ||||
|                                << " [m] PR_obs=" << obs(obs_counter) << " [m]"; | ||||
|                 } | ||||
|             else // the ephemeris are not available for this SV | ||||
|                 { | ||||
|                     // no valid pseudorange for the current SV | ||||
|                     W(obs_counter, obs_counter) = 0; // SV de-activated | ||||
|                     obs(obs_counter) = 1; // to avoid algorithm problems (divide by zero) | ||||
|                     DLOG(INFO) << "No ephemeris data for SV "<< gnss_pseudoranges_iter->first << std::endl; | ||||
|                     DLOG(INFO) << "No ephemeris data for SV "<< gnss_pseudoranges_iter->first; | ||||
|                 } | ||||
|             obs_counter++; | ||||
|         } | ||||
| // | ||||
| //    // ******************************************************************************** | ||||
| //    // ****** SOLVE LEAST SQUARES****************************************************** | ||||
| //    // ******************************************************************************** | ||||
|     // ******************************************************************************** | ||||
|     // ****** SOLVE LEAST SQUARES****************************************************** | ||||
|     // ******************************************************************************** | ||||
|     d_valid_observations = valid_obs; | ||||
|     DLOG(INFO) << "Galileo PVT: valid observations=" << valid_obs << std::endl; | ||||
|     DLOG(INFO) << "Galileo PVT: valid observations=" << valid_obs; | ||||
|  | ||||
|     if (valid_obs >= 4) | ||||
|         { | ||||
|             arma::vec mypos; | ||||
|             DLOG(INFO) << "satpos=" << satpos << std::endl; | ||||
|             DLOG(INFO) << "obs="<< obs << std::endl; | ||||
|             DLOG(INFO) << "W=" << W <<std::endl; | ||||
|             DLOG(INFO) << "satpos=" << satpos; | ||||
|             DLOG(INFO) << "obs="<< obs; | ||||
|             DLOG(INFO) << "W=" << W; | ||||
|             mypos = leastSquarePos(satpos, obs, W); | ||||
|  | ||||
|             // Compute GST and Gregorian time | ||||
|             double GST = galileo_ephemeris_iter->second.Galileo_System_Time(Galileo_week_number, galileo_current_time); | ||||
|             utc = galileo_utc_model.GST_to_UTC_time(GST, Galileo_week_number); | ||||
|             // get time string gregorian calendar | ||||
|             // get time string Gregorian calendar | ||||
|             boost::posix_time::time_duration t = boost::posix_time::seconds(utc); | ||||
|             // 22 August 1999 00:00 last Galileo start GST epoch (ICD sec 5.1.2) | ||||
|             boost::posix_time::ptime p_time(boost::gregorian::date(1999, 8, 22), t); | ||||
|             d_position_UTC_time = p_time; | ||||
|             //std::cout << "Galileo RX time at " << boost::posix_time::to_simple_string(p_time)<<std::endl; | ||||
|             DLOG(INFO) << "Galileo Position at TOW=" << galileo_current_time << " in ECEF (X,Y,Z) = " << mypos; | ||||
|  | ||||
|             DLOG(INFO) << "Galileo Position at TOW=" << galileo_current_time << " in ECEF (X,Y,Z) = " << mypos << std::endl; | ||||
|             cart2geo((double)mypos(0), (double)mypos(1), (double)mypos(2), 4); | ||||
|             //ToDo: Find an Observables/PVT random bug with some satellite configurations that gives an erratic PVT solution (i.e. height>50 km) | ||||
|             if (d_height_m > 50000) | ||||
|                 { | ||||
|                     b_valid_position = false; | ||||
|             	return false; //erratic PVT | ||||
|                     return false; | ||||
|                 } | ||||
|             DLOG(INFO) << "Galileo Position at " << boost::posix_time::to_simple_string(p_time) | ||||
|             << " is Lat = " << d_latitude_d << " [deg], Long = " << d_longitude_d | ||||
|                 << " [deg], Height= " << d_height_m << " [m]" << std::endl; | ||||
|             << " [deg], Height= " << d_height_m << " [m]"; | ||||
|  | ||||
|             // ###### Compute DOPs ######## | ||||
|  | ||||
|             // 1- Rotation matrix from ECEF coordinates to ENU coordinates | ||||
|             // ref: http://www.navipedia.net/index.php/Transformations_between_ECEF_and_ENU_coordinates | ||||
|  | ||||
|             arma::mat F = arma::zeros(3,3); | ||||
|             F(0,0) = -sin(GPS_TWO_PI*(d_longitude_d/360.0)); | ||||
|             F(0,1) = -sin(GPS_TWO_PI*(d_latitude_d/360.0))*cos(GPS_TWO_PI*(d_longitude_d/360.0)); | ||||
| @@ -390,7 +372,6 @@ bool galileo_e1_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map | ||||
|             F(2,2) = sin((GPS_TWO_PI*d_latitude_d/360.0)); | ||||
|  | ||||
|             // 2- Apply the rotation to the latest covariance matrix (available in ECEF from LS) | ||||
|  | ||||
|             arma::mat Q_ECEF = d_Q.submat(0, 0, 2, 2); | ||||
|             arma::mat DOP_ENU = arma::zeros(3, 3); | ||||
|  | ||||
| @@ -402,7 +383,8 @@ bool galileo_e1_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map | ||||
|                     d_HDOP  = sqrt(DOP_ENU(0,0) + DOP_ENU(1,1));                // HDOP | ||||
|                     d_VDOP  = sqrt(DOP_ENU(2,2));                               // VDOP | ||||
|                     d_TDOP  = sqrt(d_Q(3,3));                                   // TDOP | ||||
| 		    }catch(std::exception& ex) | ||||
|             } | ||||
|             catch(std::exception& ex) | ||||
|             { | ||||
|                     d_GDOP = -1;   // Geometric DOP | ||||
|                     d_PDOP = -1;   // PDOP | ||||
| @@ -593,8 +575,8 @@ void galileo_e1_ls_pvt::togeod(double *dphi, double *dlambda, double *h, double | ||||
|         } | ||||
|  | ||||
|     // first guess | ||||
|  | ||||
|     double P = sqrt(X*X + Y*Y); // P is distance from spin axis | ||||
|  | ||||
|     //direct calculation of longitude | ||||
|     if (P > 1.0E-20) | ||||
|         { | ||||
| @@ -604,11 +586,13 @@ void galileo_e1_ls_pvt::togeod(double *dphi, double *dlambda, double *h, double | ||||
|         { | ||||
|             *dlambda = 0; | ||||
|         } | ||||
|  | ||||
|     // correct longitude bound | ||||
|     if (*dlambda < 0) | ||||
|         { | ||||
|             *dlambda = *dlambda + 360.0; | ||||
|         } | ||||
|  | ||||
|     double r = sqrt(P*P + Z*Z); // r is distance from origin (0,0,0) | ||||
|  | ||||
|     double sinphi; | ||||
| @@ -684,7 +668,6 @@ void galileo_e1_ls_pvt::topocent(double *Az, double *El, double *D, arma::vec x, | ||||
|  | ||||
| 	      Based on a Matlab function by Kai Borre | ||||
|      */ | ||||
|  | ||||
|     double lambda; | ||||
|     double phi; | ||||
|     double h; | ||||
|   | ||||
| @@ -3,9 +3,10 @@ | ||||
|  * \brief Interface of a Least Squares Position, Velocity, and Time (PVT) | ||||
|  * solver, based on K.Borre's Matlab receiver. | ||||
|  * \author Javier Arribas, 2011. jarribas(at)cttc.es | ||||
|  * | ||||
|  * ------------------------------------------------------------------------- | ||||
|  * | ||||
|  * Copyright (C) 2010-2012  (see AUTHORS file for a list of contributors) | ||||
|  * Copyright (C) 2010-2013  (see AUTHORS file for a list of contributors) | ||||
|  * | ||||
|  * GNSS-SDR is a software defined Global Navigation | ||||
|  *          Satellite Systems receiver | ||||
| @@ -38,7 +39,6 @@ | ||||
| #include <stdio.h> | ||||
| #include <sys/time.h> | ||||
| #include <time.h> | ||||
| //#include <math.h> | ||||
| #include <cmath> | ||||
| #include <map> | ||||
| #include <algorithm> | ||||
| @@ -46,10 +46,10 @@ | ||||
| #include "galileo_navigation_message.h" | ||||
| #include "armadillo" | ||||
| #include "boost/date_time/posix_time/posix_time.hpp" | ||||
|  | ||||
| #include "gnss_synchro.h" | ||||
| #include "galileo_ephemeris.h" | ||||
| #include "galileo_utc_model.h" | ||||
|  | ||||
| #define PVT_MAX_CHANNELS 24 | ||||
|  | ||||
| /*! | ||||
| @@ -63,21 +63,18 @@ private: | ||||
|     void topocent(double *Az, double *El, double *D, arma::vec x, arma::vec dx); | ||||
|     void togeod(double *dphi, double *dlambda, double *h, double a, double finv, double X, double Y, double Z); | ||||
| public: | ||||
|     int d_nchannels;      //! Number of available channels for positioning | ||||
|     int d_valid_observations; //! Number of valid pseudorange observations (valid satellites) | ||||
|     int d_visible_satellites_IDs[PVT_MAX_CHANNELS]; //! Array with the IDs of the valid satellites | ||||
|     double d_visible_satellites_El[PVT_MAX_CHANNELS]; //! Array with the LOS Elevation of the valid satellites | ||||
|     double d_visible_satellites_Az[PVT_MAX_CHANNELS]; //! Array with the LOS Azimuth of the valid satellites | ||||
|     double d_visible_satellites_Distance[PVT_MAX_CHANNELS]; //! Array with the LOS Distance of the valid satellites | ||||
|     double d_visible_satellites_CN0_dB[PVT_MAX_CHANNELS]; //! Array with the IDs of the valid satellites | ||||
|     int d_nchannels;                                        //!< Number of available channels for positioning | ||||
|     int d_valid_observations;                               //!< Number of valid pseudorange observations (valid satellites) | ||||
|     int d_visible_satellites_IDs[PVT_MAX_CHANNELS];         //!< Array with the IDs of the valid satellites | ||||
|     double d_visible_satellites_El[PVT_MAX_CHANNELS];       //!< Array with the LOS Elevation of the valid satellites | ||||
|     double d_visible_satellites_Az[PVT_MAX_CHANNELS];       //!< Array with the LOS Azimuth of the valid satellites | ||||
|     double d_visible_satellites_Distance[PVT_MAX_CHANNELS]; //!< Array with the LOS Distance of the valid satellites | ||||
|     double d_visible_satellites_CN0_dB[PVT_MAX_CHANNELS];   //!< Array with the IDs of the valid satellites | ||||
|  | ||||
|     Galileo_Navigation_Message* d_ephemeris; | ||||
|  | ||||
|     // new ephemeris storage | ||||
|     std::map<int,Galileo_Ephemeris> galileo_ephemeris_map; | ||||
|     // new utc_model storage | ||||
|     std::map<int,Galileo_Ephemeris> galileo_ephemeris_map; //!< Map storing new Galileo_Ephemeris | ||||
|     Galileo_Utc_Model galileo_utc_model; | ||||
|     // new iono storage | ||||
|     Galileo_Iono galileo_iono; | ||||
|  | ||||
|     double d_galileo_current_time; | ||||
| @@ -85,26 +82,24 @@ public: | ||||
|  | ||||
|     bool b_valid_position; | ||||
|  | ||||
|     double d_latitude_d;  //! Latitude in degrees | ||||
|     double d_longitude_d; //! Longitude in degrees | ||||
|     double d_height_m;    //! Height [m] | ||||
|     double d_latitude_d;  //!< Latitude in degrees | ||||
|     double d_longitude_d; //!< Longitude in degrees | ||||
|     double d_height_m;    //!< Height [m] | ||||
|  | ||||
|     //averaging | ||||
|     std::deque<double> d_hist_latitude_d; | ||||
|     std::deque<double> d_hist_longitude_d; | ||||
|     std::deque<double> d_hist_height_m; | ||||
|     int d_averaging_depth;    //! Length of averaging window | ||||
|  | ||||
|     double d_avg_latitude_d;  //! Averaged latitude in degrees | ||||
|     double d_avg_longitude_d; //! Averaged longitude in degrees | ||||
|     double d_avg_height_m;    //! Averaged height [m] | ||||
|     int d_averaging_depth;    //!< Length of averaging window | ||||
|     double d_avg_latitude_d;  //!< Averaged latitude in degrees | ||||
|     double d_avg_longitude_d; //!< Averaged longitude in degrees | ||||
|     double d_avg_height_m;    //!< Averaged height [m] | ||||
|  | ||||
|     double d_x_m; | ||||
|     double d_y_m; | ||||
|     double d_z_m; | ||||
|  | ||||
|     // DOP estimations | ||||
|  | ||||
|     arma::mat d_Q; | ||||
|     double d_GDOP; | ||||
|     double d_PDOP; | ||||
| @@ -121,6 +116,7 @@ public: | ||||
|     void set_averaging_depth(int depth); | ||||
|  | ||||
|     galileo_e1_ls_pvt(int nchannels,std::string dump_filename, bool flag_dump_to_file); | ||||
|  | ||||
|     ~galileo_e1_ls_pvt(); | ||||
|  | ||||
|     bool get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map, double galileo_current_time, bool flag_averaging); | ||||
|   | ||||
| @@ -144,16 +144,6 @@ arma::vec gps_l1_ca_ls_pvt::leastSquarePos(arma::mat satpos, arma::vec obs, arma | ||||
|     omc = arma::zeros(nmbOfSatellites, 1); | ||||
|     az = arma::zeros(1, nmbOfSatellites); | ||||
|     el = arma::zeros(1, nmbOfSatellites); | ||||
|     for (int i = 0; i < nmbOfSatellites; i++) | ||||
|         { | ||||
|             for (int j = 0; j < 4; j++) | ||||
|                 { | ||||
|                     A(i, j) = 0.0; //Armadillo | ||||
|                 } | ||||
|             omc(i, 0) = 0.0; | ||||
|             az(0, i) = 0.0; | ||||
|         } | ||||
|     el = az; | ||||
|     arma::mat X = satpos; | ||||
|     arma::vec Rot_X; | ||||
|     double rho2; | ||||
| @@ -216,7 +206,6 @@ arma::vec gps_l1_ca_ls_pvt::leastSquarePos(arma::mat satpos, arma::vec obs, arma | ||||
|     try | ||||
|     { | ||||
|             //-- compute the Dilution Of Precision values | ||||
|             //arma::mat Q; | ||||
|             d_Q = arma::inv(arma::htrans(A)*A); | ||||
|     } | ||||
|     catch(std::exception& e) | ||||
| @@ -295,19 +284,18 @@ bool gps_l1_ca_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map, | ||||
|                             << " X=" << gps_ephemeris_iter->second.d_satpos_X | ||||
|                             << " [m] Y=" << gps_ephemeris_iter->second.d_satpos_Y | ||||
|                             << " [m] Z=" << gps_ephemeris_iter->second.d_satpos_Z | ||||
|                             << " [m] PR_obs=" << obs(obs_counter) << " [m]" << std::endl; | ||||
|                             << " [m] PR_obs=" << obs(obs_counter) << " [m]"; | ||||
|  | ||||
|                     // compute the UTC time for this SV (just to print the asociated UTC timestamp) | ||||
|                     GPS_week = gps_ephemeris_iter->second.i_GPS_week; | ||||
|                     utc = gps_utc_model.utc_time(TX_time_corrected_s, GPS_week); | ||||
|  | ||||
|                 } | ||||
|             else // the ephemeris are not available for this SV | ||||
|                 { | ||||
|                     // no valid pseudorange for the current SV | ||||
|                     W(obs_counter, obs_counter) = 0; // SV de-activated | ||||
|                     obs(obs_counter) = 1;            // to avoid algorithm problems (divide by zero) | ||||
|                     DLOG(INFO) << "No ephemeris data for SV "<< gnss_pseudoranges_iter->first << std::endl; | ||||
|                     DLOG(INFO) << "No ephemeris data for SV " << gnss_pseudoranges_iter->first; | ||||
|                 } | ||||
|             obs_counter++; | ||||
|         } | ||||
| @@ -316,22 +304,22 @@ bool gps_l1_ca_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map, | ||||
|     // ****** SOLVE LEAST SQUARES****************************************************** | ||||
|     // ******************************************************************************** | ||||
|     d_valid_observations = valid_obs; | ||||
|     DLOG(INFO) << "(new)PVT: valid observations=" << valid_obs << std::endl; | ||||
|     DLOG(INFO) << "(new)PVT: valid observations=" << valid_obs; | ||||
|  | ||||
|     if (valid_obs >= 4) | ||||
|         { | ||||
|             arma::vec mypos; | ||||
|             DLOG(INFO) << "satpos=" << satpos << std::endl; | ||||
|             DLOG(INFO) << "obs="<< obs << std::endl; | ||||
|             DLOG(INFO) << "W=" << W <<std::endl; | ||||
|             DLOG(INFO) << "satpos=" << satpos; | ||||
|             DLOG(INFO) << "obs=" << obs; | ||||
|             DLOG(INFO) << "W=" << W; | ||||
|             mypos = leastSquarePos(satpos, obs, W); | ||||
|             DLOG(INFO) << "(new)Position at TOW=" << GPS_current_time << " in ECEF (X,Y,Z) = " << mypos << std::endl; | ||||
|             DLOG(INFO) << "(new)Position at TOW=" << GPS_current_time << " in ECEF (X,Y,Z) = " << mypos; | ||||
|             gps_l1_ca_ls_pvt::cart2geo(mypos(0), mypos(1), mypos(2), 4); | ||||
|             //ToDo: Find an Observables/PVT random bug with some satellite configurations that gives an erratic PVT solution (i.e. height>50 km) | ||||
|             if (d_height_m > 50000) | ||||
|             { | ||||
|             	b_valid_position = false; | ||||
|             	return false; //erratic PVT | ||||
|             	return false; | ||||
|             } | ||||
|             // Compute UTC time and print PVT solution | ||||
|             double secondsperweek = 604800.0; // number of seconds in one week (7*24*60*60) | ||||
| @@ -342,13 +330,12 @@ bool gps_l1_ca_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map, | ||||
|  | ||||
|             DLOG(INFO) << "(new)Position at " << boost::posix_time::to_simple_string(p_time) | ||||
|                 << " is Lat = " << d_latitude_d << " [deg], Long = " << d_longitude_d | ||||
|                 << " [deg], Height= " << d_height_m << " [m]" << std::endl; | ||||
|                 << " [deg], Height= " << d_height_m << " [m]"; | ||||
|  | ||||
|             // ###### Compute DOPs ######## | ||||
|  | ||||
|             // 1- Rotation matrix from ECEF coordinates to ENU coordinates | ||||
|             // ref: http://www.navipedia.net/index.php/Transformations_between_ECEF_and_ENU_coordinates | ||||
|  | ||||
|             arma::mat F=arma::zeros(3,3); | ||||
|             F(0,0) = -sin(GPS_TWO_PI*(d_longitude_d/360.0)); | ||||
|             F(0,1) = -sin(GPS_TWO_PI*(d_latitude_d/360.0))*cos(GPS_TWO_PI*(d_longitude_d/360.0)); | ||||
| @@ -363,7 +350,6 @@ bool gps_l1_ca_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map, | ||||
|             F(2,2) = sin((GPS_TWO_PI*d_latitude_d/360.0)); | ||||
|  | ||||
|             // 2- Apply the rotation to the latest covariance matrix (available in ECEF from LS) | ||||
|  | ||||
|             arma::mat Q_ECEF = d_Q.submat(0, 0, 2, 2); | ||||
|             arma::mat DOP_ENU = arma::zeros(3, 3); | ||||
|  | ||||
| @@ -375,7 +361,8 @@ bool gps_l1_ca_ls_pvt::get_PVT(std::map<int,Gnss_Synchro> gnss_pseudoranges_map, | ||||
|                     d_HDOP = sqrt(DOP_ENU(0, 0) + DOP_ENU(1, 1));                // HDOP | ||||
|                     d_VDOP = sqrt(DOP_ENU(2, 2));                                // VDOP | ||||
|                     d_TDOP = sqrt(d_Q(3, 3));	                                 // TDOP | ||||
| 		    }catch(std::exception& ex) | ||||
|             } | ||||
|             catch(std::exception& ex) | ||||
|             { | ||||
|                     d_GDOP = -1; // Geometric DOP | ||||
|                     d_PDOP = -1; // PDOP | ||||
|   | ||||
| @@ -45,11 +45,9 @@ | ||||
| #include "GPS_L1_CA.h" | ||||
| #include "armadillo" | ||||
| #include "boost/date_time/posix_time/posix_time.hpp" | ||||
|  | ||||
| #include "gnss_synchro.h" | ||||
| #include "gps_ephemeris.h" | ||||
| #include "gps_utc_model.h" | ||||
|  | ||||
| #include "sbas_telemetry_data.h" | ||||
| #include "sbas_ionospheric_correction.h" | ||||
| #include "sbas_satellite_correction.h" | ||||
| @@ -68,23 +66,21 @@ private: | ||||
|     void topocent(double *Az, double *El, double *D, arma::vec x, arma::vec dx); | ||||
|     void togeod(double *dphi, double *dlambda, double *h, double a, double finv, double X, double Y, double Z); | ||||
| public: | ||||
|     int d_nchannels;      //! Number of available channels for positioning | ||||
|     int d_valid_observations; //! Number of valid pseudorange observations (valid satellites) | ||||
|     int d_visible_satellites_IDs[PVT_MAX_CHANNELS]; //! Array with the IDs of the valid satellites | ||||
|     double d_visible_satellites_El[PVT_MAX_CHANNELS]; //! Array with the LOS Elevation of the valid satellites | ||||
|     double d_visible_satellites_Az[PVT_MAX_CHANNELS]; //! Array with the LOS Azimuth of the valid satellites | ||||
|     double d_visible_satellites_Distance[PVT_MAX_CHANNELS]; //! Array with the LOS Distance of the valid satellites | ||||
|     double d_visible_satellites_CN0_dB[PVT_MAX_CHANNELS]; //! Array with the IDs of the valid satellites | ||||
|     int d_nchannels;                                        //!< Number of available channels for positioning | ||||
|     int d_valid_observations;                               //!< Number of valid pseudorange observations (valid satellites) | ||||
|     int d_visible_satellites_IDs[PVT_MAX_CHANNELS];         //!< Array with the IDs of the valid satellites | ||||
|     double d_visible_satellites_El[PVT_MAX_CHANNELS];       //!< Array with the LOS Elevation of the valid satellites | ||||
|     double d_visible_satellites_Az[PVT_MAX_CHANNELS];       //!< Array with the LOS Azimuth of the valid satellites | ||||
|     double d_visible_satellites_Distance[PVT_MAX_CHANNELS]; //!< Array with the LOS Distance of the valid satellites | ||||
|     double d_visible_satellites_CN0_dB[PVT_MAX_CHANNELS];   //!< Array with the IDs of the valid satellites | ||||
|  | ||||
|     Gps_Navigation_Message* d_ephemeris; | ||||
|  | ||||
|     // new ephemeris storage | ||||
|     std::map<int,Gps_Ephemeris> gps_ephemeris_map; | ||||
|     // new utc_model storage | ||||
|     std::map<int,Gps_Ephemeris> gps_ephemeris_map; //!< Map storing new Gps_Ephemeris | ||||
|     Gps_Utc_Model gps_utc_model; | ||||
|     // new iono storage | ||||
|     Gps_Iono gps_iono; | ||||
|     // new SBAS storage | ||||
|  | ||||
|     Sbas_Ionosphere_Correction sbas_iono; | ||||
|     std::map<int,Sbas_Satellite_Correction> sbas_sat_corr_map; | ||||
|     std::map<int,Sbas_Ephemeris> sbas_ephemeris_map; | ||||
| @@ -94,26 +90,24 @@ public: | ||||
|  | ||||
|     bool b_valid_position; | ||||
|  | ||||
|     double d_latitude_d;  //! Latitude in degrees | ||||
|     double d_longitude_d; //! Longitude in degrees | ||||
|     double d_height_m;    //! Height [m] | ||||
|     double d_latitude_d;  //!< Latitude in degrees | ||||
|     double d_longitude_d; //!< Longitude in degrees | ||||
|     double d_height_m;    //!< Height [m] | ||||
|  | ||||
|     //averaging | ||||
|     std::deque<double> d_hist_latitude_d; | ||||
|     std::deque<double> d_hist_longitude_d; | ||||
|     std::deque<double> d_hist_height_m; | ||||
|     int d_averaging_depth;    //! Length of averaging window | ||||
|  | ||||
|     double d_avg_latitude_d;  //! Averaged latitude in degrees | ||||
|     double d_avg_longitude_d; //! Averaged longitude in degrees | ||||
|     double d_avg_height_m;    //! Averaged height [m] | ||||
|     int d_averaging_depth;    //!< Length of averaging window | ||||
|     double d_avg_latitude_d;  //!< Averaged latitude in degrees | ||||
|     double d_avg_longitude_d; //!< Averaged longitude in degrees | ||||
|     double d_avg_height_m;    //!< Averaged height [m] | ||||
|  | ||||
|     double d_x_m; | ||||
|     double d_y_m; | ||||
|     double d_z_m; | ||||
|  | ||||
|     // DOP estimations | ||||
|  | ||||
|     arma::mat d_Q; | ||||
|     double d_GDOP; | ||||
|     double d_PDOP; | ||||
|   | ||||
| @@ -90,7 +90,6 @@ private: | ||||
|             gr::msg_queue::sptr queue, bool dump, | ||||
|             std::string dump_filename); | ||||
|  | ||||
|  | ||||
|     pcps_acquisition_cc(unsigned int sampled_ms, unsigned int max_dwells, | ||||
|             unsigned int doppler_max, long freq, long fs_in, | ||||
|             int samples_per_ms, int samples_per_code, | ||||
| @@ -101,7 +100,6 @@ private: | ||||
|     void calculate_magnitudes(gr_complex* fft_begin, int doppler_shift, | ||||
|             int doppler_offset); | ||||
|  | ||||
|  | ||||
|     long d_fs_in; | ||||
|     long d_freq; | ||||
|     int d_samples_per_ms; | ||||
|   | ||||
| @@ -98,11 +98,15 @@ pcps_assisted_acquisition_cc::pcps_assisted_acquisition_cc( | ||||
|     d_dump_filename = dump_filename; | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| void pcps_assisted_acquisition_cc::set_doppler_step(unsigned int doppler_step) | ||||
| { | ||||
|     d_doppler_step = doppler_step; | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| void pcps_assisted_acquisition_cc::free_grid_memory() | ||||
| { | ||||
|     for (int i = 0; i < d_num_doppler_points; i++) | ||||
| @@ -112,6 +116,9 @@ void pcps_assisted_acquisition_cc::free_grid_memory() | ||||
|         } | ||||
|     delete d_grid_data; | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| pcps_assisted_acquisition_cc::~pcps_assisted_acquisition_cc() | ||||
| { | ||||
|     free(d_carrier); | ||||
| @@ -139,17 +146,16 @@ void pcps_assisted_acquisition_cc::init() | ||||
|     d_gnss_synchro->Acq_doppler_hz = 0.0; | ||||
|     d_gnss_synchro->Acq_samplestamp_samples = 0; | ||||
|     d_input_power = 0.0; | ||||
|  | ||||
|     d_state = 0; | ||||
|  | ||||
|     d_fft_if->execute(); // We need the FFT of local code | ||||
|  | ||||
|     //Conjugate the local code | ||||
|     volk_32fc_conjugate_32fc_a(d_fft_codes, d_fft_if->get_outbuf(), d_fft_size); | ||||
|  | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| void pcps_assisted_acquisition_cc::forecast (int noutput_items, | ||||
|         gr_vector_int &ninput_items_required) | ||||
| { | ||||
| @@ -157,6 +163,7 @@ void pcps_assisted_acquisition_cc::forecast (int noutput_items, | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| void pcps_assisted_acquisition_cc::get_assistance() | ||||
| { | ||||
|     Gps_Acq_Assist gps_acq_assisistance; | ||||
| @@ -183,6 +190,9 @@ void pcps_assisted_acquisition_cc::get_assistance() | ||||
|             std::cout << "Acq assist DISABLED for GPS SV "<< this->d_gnss_synchro->PRN << std::endl; | ||||
|         } | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| void pcps_assisted_acquisition_cc::reset_grid() | ||||
| { | ||||
|     d_well_count = 0; | ||||
| @@ -194,6 +204,9 @@ void pcps_assisted_acquisition_cc::reset_grid() | ||||
|                 } | ||||
|         } | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| void pcps_assisted_acquisition_cc::redefine_grid() | ||||
| { | ||||
|     if (this->d_disable_assist == true) | ||||
| @@ -216,7 +229,6 @@ void pcps_assisted_acquisition_cc::redefine_grid() | ||||
|     d_grid_doppler_wipeoffs = new gr_complex*[d_num_doppler_points]; | ||||
|     for (int doppler_index = 0; doppler_index < d_num_doppler_points; doppler_index++) | ||||
|         { | ||||
|  | ||||
|             doppler_hz = d_doppler_min + d_doppler_step*doppler_index; | ||||
|             // doppler search steps | ||||
|             // compute the carrier doppler wipe-off signal and store it | ||||
| @@ -226,6 +238,8 @@ void pcps_assisted_acquisition_cc::redefine_grid() | ||||
|         } | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| double pcps_assisted_acquisition_cc::search_maximum() | ||||
| { | ||||
|     float magt = 0.0; | ||||
| @@ -274,6 +288,8 @@ double pcps_assisted_acquisition_cc::search_maximum() | ||||
|     return d_test_statistics; | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| float pcps_assisted_acquisition_cc::estimate_input_power(gr_vector_const_void_star &input_items) | ||||
| { | ||||
|     const gr_complex *in = (const gr_complex *)input_items[0]; //Get the input samples pointer | ||||
| @@ -289,6 +305,8 @@ float pcps_assisted_acquisition_cc::estimate_input_power(gr_vector_const_void_st | ||||
|     return ( power / (float)d_fft_size); | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| int pcps_assisted_acquisition_cc::compute_and_accumulate_grid(gr_vector_const_void_star &input_items) | ||||
| { | ||||
|     // initialize acquisition algorithm | ||||
| @@ -325,7 +343,6 @@ int pcps_assisted_acquisition_cc::compute_and_accumulate_grid(gr_vector_const_vo | ||||
|             volk_32fc_magnitude_squared_32f_a(p_tmp_vector, d_ifft->get_outbuf(), d_fft_size); | ||||
|             const float*  old_vector = d_grid_data[doppler_index]; | ||||
|             volk_32f_x2_add_32f_a(d_grid_data[doppler_index], old_vector, p_tmp_vector, d_fft_size); | ||||
|  | ||||
|         } | ||||
|     free(p_tmp_vector); | ||||
|     return d_fft_size; | ||||
| @@ -334,7 +351,6 @@ int pcps_assisted_acquisition_cc::general_work(int noutput_items, | ||||
|         gr_vector_int &ninput_items, gr_vector_const_void_star &input_items, | ||||
|         gr_vector_void_star &output_items) | ||||
| { | ||||
|  | ||||
|     /*! | ||||
|      * TODO: 	High sensitivity acquisition algorithm: | ||||
|      * 			State Mechine: | ||||
| @@ -418,7 +434,6 @@ int pcps_assisted_acquisition_cc::general_work(int noutput_items, | ||||
|         DLOG(INFO) << "code phase " << d_gnss_synchro->Acq_delay_samples; | ||||
|         DLOG(INFO) << "doppler " << d_gnss_synchro->Acq_doppler_hz; | ||||
|         DLOG(INFO) << "input signal power " << d_input_power; | ||||
|  | ||||
|         d_active = false; | ||||
|         // Send message to channel queue //0=STOP_CHANNEL 1=ACQ_SUCCESS 2=ACQ_FAIL | ||||
|         d_channel_internal_queue->push(1); // 1-> positive acquisition | ||||
| @@ -437,7 +452,6 @@ int pcps_assisted_acquisition_cc::general_work(int noutput_items, | ||||
|         DLOG(INFO) << "code phase " << d_gnss_synchro->Acq_delay_samples; | ||||
|         DLOG(INFO) << "doppler " << d_gnss_synchro->Acq_doppler_hz; | ||||
|         DLOG(INFO) << "input signal power " << d_input_power; | ||||
|  | ||||
|         d_active = false; | ||||
|         // Send message to channel queue //0=STOP_CHANNEL 1=ACQ_SUCCESS 2=ACQ_FAIL | ||||
|         d_channel_internal_queue->push(2); // 2-> negative acquisition | ||||
|   | ||||
| @@ -45,8 +45,8 @@ | ||||
|  * ------------------------------------------------------------------------- | ||||
|  */ | ||||
|  | ||||
| #ifndef GNSS_SDR_PCPS_assisted_acquisition_cc_H_ | ||||
| #define GNSS_SDR_PCPS_assisted_acquisition_cc_H_ | ||||
| #ifndef GNSS_SDR_PCPS_ASSISTED_ACQUISITION_CC_H_ | ||||
| #define GNSS_SDR_PCPS_ASSISTED_ACQUISITION_CC_H_ | ||||
|  | ||||
| #include <fstream> | ||||
| #include <gnuradio/block.h> | ||||
| @@ -75,7 +75,6 @@ pcps_make_assisted_acquisition_cc(int max_dwells, unsigned int sampled_ms, | ||||
|  * Check \ref Navitec2012 "An Open Source Galileo E1 Software Receiver", | ||||
|  * Algorithm 1, for a pseudocode description of this implementation. | ||||
|  */ | ||||
|  | ||||
| class pcps_assisted_acquisition_cc: public gr::block | ||||
| { | ||||
| private: | ||||
| @@ -223,7 +222,6 @@ public: | ||||
|      */ | ||||
|     void set_doppler_step(unsigned int doppler_step); | ||||
|  | ||||
|  | ||||
|     /*! | ||||
|      * \brief Set tracking channel internal queue. | ||||
|      * \param channel_internal_queue - Channel's internal blocks information queue. | ||||
| @@ -241,7 +239,6 @@ public: | ||||
|             gr_vector_void_star &output_items); | ||||
|  | ||||
|     void forecast (int noutput_items, gr_vector_int &ninput_items_required); | ||||
|  | ||||
| }; | ||||
|  | ||||
| #endif /* GNSS_SDR_PCPS_assisted_acquisition_cc_H_*/ | ||||
|   | ||||
| @@ -84,7 +84,6 @@ private: | ||||
|     void calculate_magnitudes(gr_complex* fft_begin, int doppler_shift, | ||||
|             int doppler_offset); | ||||
|  | ||||
|  | ||||
|     long d_fs_in; | ||||
|     long d_freq; | ||||
|     int d_samples_per_ms; | ||||
| @@ -208,7 +207,6 @@ public: | ||||
|          d_doppler_step = doppler_step; | ||||
|      } | ||||
|  | ||||
|  | ||||
|      /*! | ||||
|       * \brief Set tracking channel internal queue. | ||||
|       * \param channel_internal_queue - Channel's internal blocks information queue. | ||||
| @@ -224,7 +222,6 @@ public: | ||||
|      int general_work(int noutput_items, gr_vector_int &ninput_items, | ||||
|              gr_vector_const_void_star &input_items, | ||||
|              gr_vector_void_star &output_items); | ||||
|  | ||||
| }; | ||||
|  | ||||
| #endif /* GNSS_SDR_PCPS_CCCWSR_ACQUISITION_CC_H_*/ | ||||
|   | ||||
| @@ -146,6 +146,8 @@ pcps_opencl_acquisition_cc::pcps_opencl_acquisition_cc( | ||||
|  | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| pcps_opencl_acquisition_cc::~pcps_opencl_acquisition_cc() | ||||
| { | ||||
|     if (d_num_doppler_bins > 0) | ||||
| @@ -194,6 +196,8 @@ pcps_opencl_acquisition_cc::~pcps_opencl_acquisition_cc() | ||||
|         } | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| int pcps_opencl_acquisition_cc::init_opencl_environment(std::string kernel_filename) | ||||
| { | ||||
|     //get all platforms (drivers) | ||||
| @@ -284,6 +288,8 @@ int pcps_opencl_acquisition_cc::init_opencl_environment(std::string kernel_filen | ||||
|     return 0; | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| void pcps_opencl_acquisition_cc::init() | ||||
| { | ||||
|     d_gnss_synchro->Acq_delay_samples = 0.0; | ||||
| @@ -669,13 +675,13 @@ void pcps_opencl_acquisition_cc::acquisition_core_opencl() | ||||
|     d_core_working = false; | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| int pcps_opencl_acquisition_cc::general_work(int noutput_items, | ||||
|         gr_vector_int &ninput_items, gr_vector_const_void_star &input_items, | ||||
|         gr_vector_void_star &output_items) | ||||
| { | ||||
|  | ||||
|     int acquisition_message = -1; //0=STOP_CHANNEL 1=ACQ_SUCCEES 2=ACQ_FAIL | ||||
|  | ||||
|     switch (d_state) | ||||
|     { | ||||
|     case 0: | ||||
|   | ||||
| @@ -98,7 +98,6 @@ private: | ||||
|             gr::msg_queue::sptr queue, bool dump, | ||||
|             std::string dump_filename); | ||||
|  | ||||
|  | ||||
|     pcps_opencl_acquisition_cc(unsigned int sampled_ms, unsigned int max_dwells, | ||||
|             unsigned int doppler_max, long freq, long fs_in, | ||||
|             int samples_per_ms, int samples_per_code, | ||||
| @@ -274,4 +273,4 @@ public: | ||||
|      void acquisition_core_opencl(); | ||||
| }; | ||||
|  | ||||
| #endif /* GNSS_SDR_pcps_opencl_acquisition_cc_H_*/ | ||||
| #endif | ||||
|   | ||||
| @@ -87,7 +87,6 @@ private: | ||||
|             unsigned int tong_max_val, gr::msg_queue::sptr queue, | ||||
|             bool dump, std::string dump_filename); | ||||
|  | ||||
|  | ||||
|     pcps_tong_acquisition_cc(unsigned int sampled_ms, unsigned int doppler_max, | ||||
|             long freq, long fs_in, int samples_per_ms, | ||||
|             int samples_per_code, unsigned int tong_init_val, | ||||
| @@ -97,7 +96,6 @@ private: | ||||
|     void calculate_magnitudes(gr_complex* fft_begin, int doppler_shift, | ||||
|             int doppler_offset); | ||||
|  | ||||
|  | ||||
|     long d_fs_in; | ||||
|     long d_freq; | ||||
|     int d_samples_per_ms; | ||||
|   | ||||
| @@ -41,7 +41,7 @@ | ||||
| class ConfigurationInterface; | ||||
|  | ||||
| /*! | ||||
|  * \brief This class implements an ObservablesInterface for Galileo E1 | ||||
|  * \brief This class implements an ObservablesInterface for Galileo E1B | ||||
|  */ | ||||
| class GalileoE1Observables : public ObservablesInterface | ||||
| { | ||||
| @@ -57,6 +57,7 @@ public: | ||||
|         return role_; | ||||
|     } | ||||
|  | ||||
|     //!  Returns "Galileo_E1B_Observables" | ||||
|     std::string implementation() | ||||
|     { | ||||
|         return "Galileo_E1B_Observables"; | ||||
|   | ||||
| @@ -1,6 +1,6 @@ | ||||
| /*! | ||||
|  * \file gps_l1_ca_observables_cc.cc | ||||
|  * \brief Implementation of the pseudorange computation block for GPS L1 C/A | ||||
|  * \file galileo_e1_observables_cc.cc | ||||
|  * \brief Implementation of the pseudorange computation block for Galileo E1 | ||||
|  * \author Mara Branzanti 2013. mara.branzanti(at)gmail.com | ||||
|  * \author Javier Arribas 2013. jarribas(at)cttc.es | ||||
|  * | ||||
| @@ -92,12 +92,15 @@ galileo_e1_observables_cc::~galileo_e1_observables_cc() | ||||
|     d_dump_file.close(); | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| bool Galileo_pairCompare_gnss_synchro_Prn_delay_ms( std::pair<int,Gnss_Synchro> a, std::pair<int,Gnss_Synchro> b) | ||||
| { | ||||
|     return (a.second.Prn_timestamp_ms) < (b.second.Prn_timestamp_ms); | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| bool Galileo_pairCompare_gnss_synchro_d_TOW_at_current_symbol( std::pair<int,Gnss_Synchro> a, std::pair<int,Gnss_Synchro> b) | ||||
| { | ||||
|     return (a.second.d_TOW_at_current_symbol) < (b.second.d_TOW_at_current_symbol); | ||||
| @@ -118,7 +121,7 @@ int galileo_e1_observables_cc::general_work (int noutput_items, gr_vector_int &n | ||||
|     /* | ||||
|      * 1. Read the GNSS SYNCHRO objects from available channels | ||||
|      */ | ||||
|     for (unsigned int i=0; i<d_nchannels ; i++) //legge gli input per ogni canale e prepare i dati da riempire | ||||
|     for (unsigned int i = 0; i < d_nchannels; i++) | ||||
|         { | ||||
|             //Copy the telemetry decoder data to local copy | ||||
|             current_gnss_synchro[i] = in[i][0]; | ||||
| @@ -127,12 +130,13 @@ int galileo_e1_observables_cc::general_work (int noutput_items, gr_vector_int &n | ||||
|              */ | ||||
|             current_gnss_synchro[i].Flag_valid_pseudorange = false; | ||||
|             current_gnss_synchro[i].Pseudorange_m = 0.0; | ||||
|             if (current_gnss_synchro[i].Flag_valid_word) //if this channel have valid word, ciò viene definito nel telemetry decoder | ||||
|             if (current_gnss_synchro[i].Flag_valid_word) | ||||
|                 { | ||||
|                     //record the word structure in a map for pseudorange computation | ||||
|                     current_gnss_synchro_map.insert(std::pair<int, Gnss_Synchro>(current_gnss_synchro[i].Channel_ID, current_gnss_synchro[i])); | ||||
|                 } | ||||
|         } | ||||
|  | ||||
|     /* | ||||
|      * 2. Compute RAW pseudoranges using COMMON RECEPTION TIME algorithm. Use only the valid channels (channels that are tracking a satellite) | ||||
|      */ | ||||
| @@ -142,14 +146,13 @@ int galileo_e1_observables_cc::general_work (int noutput_items, gr_vector_int &n | ||||
|              *  2.1 Use CURRENT set of measurements and find the nearest satellite | ||||
|              *  common RX time algorithm | ||||
|              */ | ||||
|             //; | ||||
|             // what is the most recent symbol TOW in the current set? -> this will be the reference symbol | ||||
|             gnss_synchro_iter = max_element(current_gnss_synchro_map.begin(), current_gnss_synchro_map.end(), Galileo_pairCompare_gnss_synchro_d_TOW_at_current_symbol); | ||||
|             double d_TOW_reference = gnss_synchro_iter->second.d_TOW_at_current_symbol; | ||||
|             double d_ref_PRN_rx_time_ms = gnss_synchro_iter->second.Prn_timestamp_ms; | ||||
|             //int reference_channel= gnss_synchro_iter->second.Channel_ID; | ||||
|  | ||||
|               // Now compute RX time differences due to the PRN alignement in the correlators | ||||
|             // Now compute RX time differences due to the PRN alignment in the correlators | ||||
|             double traveltime_ms; | ||||
|             double pseudorange_m; | ||||
|             double delta_rx_time_ms; | ||||
| @@ -157,23 +160,17 @@ int galileo_e1_observables_cc::general_work (int noutput_items, gr_vector_int &n | ||||
|                 { | ||||
|                     // compute the required symbol history shift in order to match the reference symbol | ||||
|                     delta_rx_time_ms = gnss_synchro_iter->second.Prn_timestamp_ms-d_ref_PRN_rx_time_ms; | ||||
|             	//std::cout<<"delta_rx_time_ms["<<gnss_synchro_iter->second.Channel_ID<<"]="<<delta_rx_time_ms<<std::endl; | ||||
|             	//std::cout<<"d_TOW_at_current_symbol["<<gnss_synchro_iter->second.Channel_ID<<"]="<<gnss_synchro_iter->second.d_TOW_at_current_symbol<<std::endl; | ||||
|                     //compute the pseudorange | ||||
|                     traveltime_ms = (d_TOW_reference - gnss_synchro_iter->second.d_TOW_at_current_symbol)*1000.0 + delta_rx_time_ms + GALILEO_STARTOFFSET_ms; | ||||
|             	//std::cout<<"traveltime_ms="<<traveltime_ms<<std::endl; | ||||
|                     pseudorange_m = traveltime_ms * GALILEO_C_m_ms; // [m] | ||||
|             	//std::cout<<"pseudorange_m["<<gnss_synchro_iter->second.Channel_ID<<"]="<<pseudorange_m<<std::endl; | ||||
|                     // update the pseudorange object | ||||
|                     //current_gnss_synchro[gnss_synchro_iter->second.Channel_ID] = gnss_synchro_iter->second; | ||||
|                     current_gnss_synchro[gnss_synchro_iter->second.Channel_ID].Pseudorange_m = pseudorange_m; | ||||
|                     current_gnss_synchro[gnss_synchro_iter->second.Channel_ID].Flag_valid_pseudorange = true; | ||||
|                     current_gnss_synchro[gnss_synchro_iter->second.Channel_ID].d_TOW_at_current_symbol = round(d_TOW_reference*1000)/1000 + GALILEO_STARTOFFSET_ms/1000.0; | ||||
|                 } | ||||
|  | ||||
|         } | ||||
|  | ||||
|  | ||||
|       if(d_dump == true) | ||||
|         { | ||||
|             // MULTIPLEXED FILE RECORDING - Record results to file | ||||
|   | ||||
| @@ -40,11 +40,9 @@ | ||||
| #include <boost/thread/mutex.hpp> | ||||
| #include <boost/thread/thread.hpp> | ||||
| #include "concurrent_queue.h" | ||||
|  | ||||
| #include "galileo_navigation_message.h" | ||||
| #include "rinex_printer.h" | ||||
| #include "Galileo_E1.h" | ||||
|  | ||||
| #include "gnss_synchro.h" | ||||
|  | ||||
| class galileo_e1_observables_cc; | ||||
|   | ||||
| @@ -90,6 +90,7 @@ gps_l1_ca_observables_cc::~gps_l1_ca_observables_cc() | ||||
|     d_dump_file.close(); | ||||
| } | ||||
|  | ||||
|  | ||||
| bool pairCompare_gnss_synchro_Prn_delay_ms( std::pair<int,Gnss_Synchro> a, std::pair<int,Gnss_Synchro> b) | ||||
| { | ||||
|     return (a.second.Prn_timestamp_ms) < (b.second.Prn_timestamp_ms); | ||||
| @@ -131,6 +132,7 @@ int gps_l1_ca_observables_cc::general_work (int noutput_items, gr_vector_int &ni | ||||
|                     current_gnss_synchro_map.insert(std::pair<int, Gnss_Synchro>(current_gnss_synchro[i].Channel_ID, current_gnss_synchro[i])); | ||||
|                 } | ||||
|         } | ||||
|  | ||||
|     /* | ||||
|      * 2. Compute RAW pseudoranges using COMMON RECEPTION TIME algorithm. Use only the valid channels (channels that are tracking a satellite) | ||||
|      */ | ||||
| @@ -140,14 +142,13 @@ int gps_l1_ca_observables_cc::general_work (int noutput_items, gr_vector_int &ni | ||||
|              *  2.1 Use CURRENT set of measurements and find the nearest satellite | ||||
|              *  common RX time algorithm | ||||
|              */ | ||||
|             //; | ||||
|             // what is the most recent symbol TOW in the current set? -> this will be the reference symbol | ||||
|             gnss_synchro_iter = max_element(current_gnss_synchro_map.begin(), current_gnss_synchro_map.end(), pairCompare_gnss_synchro_d_TOW_at_current_symbol); | ||||
|             double d_TOW_reference = gnss_synchro_iter->second.d_TOW_at_current_symbol; | ||||
|             double d_ref_PRN_rx_time_ms = gnss_synchro_iter->second.Prn_timestamp_ms; | ||||
|             //int reference_channel= gnss_synchro_iter->second.Channel_ID; | ||||
|  | ||||
|             // Now compute RX time differences due to the PRN alignement in the correlators | ||||
|             // Now compute RX time differences due to the PRN alignment in the correlators | ||||
|             double traveltime_ms; | ||||
|             double pseudorange_m; | ||||
|             double delta_rx_time_ms; | ||||
| @@ -155,7 +156,6 @@ int gps_l1_ca_observables_cc::general_work (int noutput_items, gr_vector_int &ni | ||||
|             { | ||||
|             	// compute the required symbol history shift in order to match the reference symbol | ||||
|             	delta_rx_time_ms = gnss_synchro_iter->second.Prn_timestamp_ms - d_ref_PRN_rx_time_ms; | ||||
|             	//std::cout<<"delta_rx_time_ms="<<delta_rx_time_ms<<std::endl; | ||||
|             	//compute the pseudorange | ||||
|             	traveltime_ms = (d_TOW_reference-gnss_synchro_iter->second.d_TOW_at_current_symbol)*1000.0 + delta_rx_time_ms + GPS_STARTOFFSET_ms; | ||||
|             	pseudorange_m = traveltime_ms * GPS_C_m_ms; // [m] | ||||
| @@ -167,7 +167,6 @@ int gps_l1_ca_observables_cc::general_work (int noutput_items, gr_vector_int &ni | ||||
|             } | ||||
|         } | ||||
|  | ||||
|  | ||||
|     if(d_dump == true) | ||||
|         { | ||||
|             // MULTIPLEXED FILE RECORDING - Record results to file | ||||
|   | ||||
| @@ -76,7 +76,7 @@ void galileo_e1b_telemetry_decoder_cc::viterbi_decoder(double *page_part_symbols | ||||
|     nn = 2;             // Coding rate 1/n | ||||
|     KK = 7;             // Constraint Length | ||||
|     g_encoder[0] = 121; // Polynomial G1 | ||||
|     g_encoder[1] = 91; // Polinomial G2 | ||||
|     g_encoder[1] = 91;  // Polynomial G2 | ||||
|  | ||||
|     mm = KK - 1; | ||||
|     max_states = 1 << mm; /* 2^mm */ | ||||
| @@ -95,7 +95,6 @@ void galileo_e1b_telemetry_decoder_cc::viterbi_decoder(double *page_part_symbols | ||||
|     Viterbi(page_part_bits, out0, state0, out1, state1, | ||||
|             page_part_symbols, KK, nn, DataLength ); | ||||
|  | ||||
|  | ||||
|     /* Clean up memory */ | ||||
|     free( out0 ); | ||||
|     free( out1 ); | ||||
|   | ||||
| @@ -1,12 +1,12 @@ | ||||
| /*! | ||||
|  * \file galileo_e1b_telemetry_decoder_cc.h | ||||
|  * \brief Interface of a Galileo NAV message demodulator block | ||||
|  * \brief Interface of a Galileo INAV message demodulator block | ||||
|  * \author Javier Arribas 2013 jarribas(at)cttc.es, | ||||
|  *         Mara Branzanti 2013 mara.branzanti(at)gmail.com | ||||
|  * | ||||
|  * ------------------------------------------------------------------------- | ||||
|  * | ||||
|  * Copyright (C) 2010-2011  (see AUTHORS file for a list of contributors) | ||||
|  * Copyright (C) 2010-2013  (see AUTHORS file for a list of contributors) | ||||
|  * | ||||
|  * GNSS-SDR is a software defined Global Navigation | ||||
|  *          Satellite Systems receiver | ||||
| @@ -42,7 +42,6 @@ | ||||
| #include "gnuradio/trellis/interleaver.h" | ||||
| #include "gnuradio/trellis/permutation.h" | ||||
| #include "gnuradio/fec/viterbi.h" | ||||
|  | ||||
| #include "gnss_satellite.h" | ||||
| #include "galileo_navigation_message.h" | ||||
| #include "galileo_ephemeris.h" | ||||
| @@ -50,19 +49,13 @@ | ||||
| #include "galileo_iono.h" | ||||
| #include "galileo_utc_model.h" | ||||
|  | ||||
| // Galileo Navigation Message structures | ||||
| #include "galileo_ephemeris.h" | ||||
| #include "galileo_iono.h" | ||||
| #include "galileo_almanac.h" | ||||
| #include "galileo_utc_model.h" | ||||
|  | ||||
|  | ||||
| class galileo_e1b_telemetry_decoder_cc; | ||||
|  | ||||
| typedef boost::shared_ptr<galileo_e1b_telemetry_decoder_cc> galileo_e1b_telemetry_decoder_cc_sptr; | ||||
|  | ||||
| galileo_e1b_telemetry_decoder_cc_sptr | ||||
| galileo_e1b_make_telemetry_decoder_cc(Gnss_Satellite satellite, long if_freq, long fs_in, unsigned | ||||
| galileo_e1b_telemetry_decoder_cc_sptr galileo_e1b_make_telemetry_decoder_cc(Gnss_Satellite satellite, long if_freq, long fs_in, unsigned | ||||
|     int vector_length, boost::shared_ptr<gr::msg_queue> queue, bool dump); | ||||
|  | ||||
| /*! | ||||
|   | ||||
| @@ -114,20 +114,19 @@ private: | ||||
|         void reset(); | ||||
|         /* | ||||
|          * samples length must be a multiple of two | ||||
|          * for block operation the | ||||
|          * for block operation | ||||
|          */ | ||||
|        bool get_symbols(const std::vector<double> samples, std::vector<double> &symbols); | ||||
|     private: | ||||
|         int d_n_smpls_in_history ; | ||||
|         double d_iir_par; | ||||
|  | ||||
|         double d_corr_paired; | ||||
|         double d_corr_shifted; | ||||
|         bool d_aligned; | ||||
|         double d_past_sample; | ||||
|     } d_sample_aligner; | ||||
|  | ||||
|     // helper class for symbol alignment and viterbi decoding | ||||
|     // helper class for symbol alignment and Viterbi decoding | ||||
|     class symbol_aligner_and_decoder | ||||
|     { | ||||
|     public: | ||||
| @@ -140,7 +139,6 @@ private: | ||||
|         Viterbi_Decoder * d_vd1; | ||||
|         Viterbi_Decoder * d_vd2; | ||||
|         double d_past_symbol; | ||||
|  | ||||
|     } d_symbol_aligner_and_decoder; | ||||
|  | ||||
|  | ||||
|   | ||||
| @@ -31,7 +31,6 @@ | ||||
|  | ||||
| #include "viterbi_decoder.h" | ||||
| #include <iostream> | ||||
|  | ||||
| #include <glog/log_severity.h> | ||||
| #include <glog/logging.h> | ||||
|  | ||||
| @@ -97,7 +96,7 @@ void Viterbi_Decoder::reset() | ||||
|  Description: Uses the Viterbi algorithm to perform hard-decision decoding of a convolutional code. | ||||
|  Input parameters: | ||||
|  r[]	The received signal in LLR-form. For BPSK, must be in form r = 2*a*y/(sigma^2). | ||||
|  LL	The number of data bits to be decoded (doen't inlcude the mm zero-tail-bits) | ||||
|  LL	The number of data bits to be decoded (doesn't include the mm zero-tail-bits) | ||||
|  Output parameters: | ||||
|  output_u_int[]	Hard decisions on the data bits (without the mm zero-tail-bits) | ||||
|  */ | ||||
| @@ -141,12 +140,10 @@ float Viterbi_Decoder::decode_continuous(const double sym[], | ||||
|     // since it depends on the future values -> traceback, but don't decode | ||||
|     state = do_traceback(traceback_depth); | ||||
|     // traceback and decode | ||||
|     decoding_length_mismatch = do_tb_and_decode(traceback_depth, nbits_requested, state,  bits, | ||||
|             d_indicator_metric); | ||||
|     decoding_length_mismatch = do_tb_and_decode(traceback_depth, nbits_requested, state,  bits, d_indicator_metric); | ||||
|     nbits_decoded = nbits_requested + decoding_length_mismatch; | ||||
|  | ||||
|     VLOG(FLOW) << "decoding length mismatch (continuous decoding): " | ||||
|             << decoding_length_mismatch; | ||||
|     VLOG(FLOW) << "decoding length mismatch (continuous decoding): " << decoding_length_mismatch; | ||||
|  | ||||
|     return d_indicator_metric; | ||||
| } | ||||
| @@ -332,8 +329,6 @@ int Viterbi_Decoder::do_tb_and_decode(int traceback_length, int requested_decodi | ||||
|     indicator_metric = 0; | ||||
|     for (it = d_trellis_paths.begin() + traceback_length + overstep_length; it < d_trellis_paths.end(); ++it) | ||||
|         { | ||||
|             //VLOG(SAMPLE)<< "@t_out=" << t_out; | ||||
|             //VLOG(SAMPLE) << "tb&dec: @t=" << it->get_t() << " bit=" << it->get_bit_of_current_state(state) << " bm=" << it->get_metric_of_current_state(state); | ||||
|             if(it - (d_trellis_paths.begin() + traceback_length + overstep_length) < n_of_branches_for_indicator_metric) | ||||
|                 { | ||||
|                     n_im++; | ||||
|   | ||||
| @@ -35,6 +35,9 @@ | ||||
| #include <deque> | ||||
| #include <iostream> | ||||
|  | ||||
| /*! | ||||
|  * \brief Class that implements a Viterbi decoder | ||||
|  */ | ||||
| class Viterbi_Decoder | ||||
| { | ||||
| public: | ||||
| @@ -45,8 +48,8 @@ public: | ||||
|     /*! | ||||
|      * \brief Uses the Viterbi algorithm to perform hard-decision decoding of a convolutional code. | ||||
|      * | ||||
|      * \param  input_c[]    The received signal in LLR-form. For BPSK, must be in form r = 2*a*y/(sigma^2). | ||||
|      * \param  LL           The number of data bits to be decoded (does not include the mm zero-tail-bits) | ||||
|      * \param[in]  input_c[]    The received signal in LLR-form. For BPSK, must be in form r = 2*a*y/(sigma^2). | ||||
|      * \param[in]  LL           The number of data bits to be decoded (does not include the mm zero-tail-bits) | ||||
|      * | ||||
|      * \return  output_u_int[] Hard decisions on the data bits (without the mm zero-tail-bits) | ||||
|      */ | ||||
|   | ||||
| @@ -44,12 +44,12 @@ | ||||
|  | ||||
| class ConfigurationInterface; | ||||
|  | ||||
|  | ||||
| /*! | ||||
|  * \brief This class implements a code DLL + carrier PLL/FLL Assisted tracking loop | ||||
|  */ | ||||
| class GpsL1CaDllFllPllTracking : public TrackingInterface | ||||
| { | ||||
|  | ||||
| public: | ||||
|  | ||||
|   GpsL1CaDllFllPllTracking(ConfigurationInterface* configuration, | ||||
|             std::string role, | ||||
|             unsigned int in_streams, | ||||
| @@ -80,19 +80,13 @@ public: | ||||
|  | ||||
|     void set_channel(unsigned int channel); | ||||
|     void set_channel_queue(concurrent_queue<int> *channel_internal_queue); | ||||
|  | ||||
|     void set_gnss_synchro(Gnss_Synchro* p_gnss_synchro); | ||||
|  | ||||
|     void start_tracking(); | ||||
|  | ||||
|  | ||||
| private: | ||||
|  | ||||
|     gps_l1_ca_dll_fll_pll_tracking_cc_sptr tracking_; | ||||
|     size_t item_size_; | ||||
|  | ||||
|     unsigned int channel_; | ||||
|  | ||||
|     std::string role_; | ||||
|     unsigned int in_streams_; | ||||
|     unsigned int out_streams_; | ||||
|   | ||||
| @@ -45,7 +45,6 @@ | ||||
| #include <iostream> | ||||
| #include <sstream> | ||||
| #include <cmath> | ||||
| //#include "math.h" | ||||
| #include <gnuradio/io_signature.h> | ||||
| #include <glog/log_severity.h> | ||||
| #include <glog/logging.h> | ||||
| @@ -78,12 +77,14 @@ galileo_e1_dll_pll_veml_make_tracking_cc( | ||||
|             fs_in, vector_length, queue, dump, dump_filename, pll_bw_hz, dll_bw_hz, early_late_space_chips, very_early_late_space_chips)); | ||||
| } | ||||
|  | ||||
|  | ||||
| void galileo_e1_dll_pll_veml_tracking_cc::forecast (int noutput_items, | ||||
|         gr_vector_int &ninput_items_required) | ||||
| { | ||||
|     ninput_items_required[0] = (int)d_vector_length*2; //set the required available samples in each call | ||||
| } | ||||
|  | ||||
|  | ||||
| galileo_e1_dll_pll_veml_tracking_cc::galileo_e1_dll_pll_veml_tracking_cc( | ||||
|         long if_freq, | ||||
|         long fs_in, | ||||
| @@ -123,7 +124,6 @@ galileo_e1_dll_pll_veml_tracking_cc::galileo_e1_dll_pll_veml_tracking_cc( | ||||
|     // Get space for a vector with the sinboc(1,1) replica sampled 2x/chip | ||||
|     d_ca_code = new gr_complex[(int)(2*Galileo_E1_B_CODE_LENGTH_CHIPS + 4)]; | ||||
|  | ||||
|  | ||||
|     /* If an array is partitioned for more than one thread to operate on, | ||||
|      * having the sub-array boundaries unaligned to cache lines could lead | ||||
|      * to performance degradation. Here we allocate memory | ||||
| @@ -145,7 +145,6 @@ galileo_e1_dll_pll_veml_tracking_cc::galileo_e1_dll_pll_veml_tracking_cc( | ||||
|     if (posix_memalign((void**)&d_Late, 16, sizeof(gr_complex)) == 0){}; | ||||
|     if (posix_memalign((void**)&d_Very_Late, 16, sizeof(gr_complex)) == 0){}; | ||||
|  | ||||
|  | ||||
|     //--- Initializations ------------------------------ | ||||
|     // Initial code frequency basis of NCO | ||||
|     d_code_freq_chips = Galileo_E1_CODE_CHIP_RATE_HZ; | ||||
| @@ -187,7 +186,12 @@ void galileo_e1_dll_pll_veml_tracking_cc::start_tracking() | ||||
|     d_code_loop_filter.initialize();    // initialize the code filter | ||||
|  | ||||
|     // generate local reference ALWAYS starting at chip 2 (2 samples per chip) | ||||
|     galileo_e1_code_gen_complex_sampled(&d_ca_code[2],d_acquisition_gnss_synchro->Signal, false, d_acquisition_gnss_synchro->PRN, 2*Galileo_E1_CODE_CHIP_RATE_HZ, 0); | ||||
|     galileo_e1_code_gen_complex_sampled(&d_ca_code[2], | ||||
|                                         d_acquisition_gnss_synchro->Signal, | ||||
|                                         false, | ||||
|                                         d_acquisition_gnss_synchro->PRN, | ||||
|                                         2*Galileo_E1_CODE_CHIP_RATE_HZ, | ||||
|                                         0); | ||||
|     // Fill head and tail | ||||
|     d_ca_code[0] = d_ca_code[(int)(2*Galileo_E1_B_CODE_LENGTH_CHIPS)]; | ||||
|     d_ca_code[1] = d_ca_code[(int)(2*Galileo_E1_B_CODE_LENGTH_CHIPS + 1)]; | ||||
| @@ -207,8 +211,9 @@ void galileo_e1_dll_pll_veml_tracking_cc::start_tracking() | ||||
|     sys = sys_.substr(0, 1); | ||||
|  | ||||
|     // DEBUG OUTPUT | ||||
|     std::cout << "Tracking start on channel " << d_channel << " for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN) << std::endl; | ||||
|     DLOG(INFO) << "Start tracking for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN)  << " received" << std::endl; | ||||
|     std::cout << "Tracking start on channel " << d_channel | ||||
|               << " for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN) << std::endl; | ||||
|     DLOG(INFO) << "Start tracking for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN)  << " received"; | ||||
|  | ||||
|     // enable tracking | ||||
|     d_pull_in = true; | ||||
| @@ -356,9 +361,9 @@ int galileo_e1_dll_pll_veml_tracking_cc::general_work (int noutput_items,gr_vect | ||||
|             d_carrier_doppler_hz = d_acq_carrier_doppler_hz + carr_error_filt_hz; | ||||
|             // New code Doppler frequency estimation | ||||
|             d_code_freq_chips = Galileo_E1_CODE_CHIP_RATE_HZ + ((d_carrier_doppler_hz * Galileo_E1_CODE_CHIP_RATE_HZ) / Galileo_E1_FREQ_HZ); | ||||
|             //carrier phase accumulator for (K) doppler estimation | ||||
|             //carrier phase accumulator for (K) Doppler estimation | ||||
|             d_acc_carrier_phase_rad = d_acc_carrier_phase_rad + GPS_TWO_PI * d_carrier_doppler_hz * Galileo_E1_CODE_PERIOD; | ||||
|             //remanent carrier phase to prevent overflow in the code NCO | ||||
|             //remnant carrier phase to prevent overflow in the code NCO | ||||
|             d_rem_carr_phase_rad = d_rem_carr_phase_rad + GPS_TWO_PI* d_carrier_doppler_hz * Galileo_E1_CODE_PERIOD; | ||||
|             d_rem_carr_phase_rad = fmod(d_rem_carr_phase_rad, GPS_TWO_PI); | ||||
|  | ||||
| @@ -440,6 +445,7 @@ int galileo_e1_dll_pll_veml_tracking_cc::general_work (int noutput_items,gr_vect | ||||
|             current_synchro_data.Carrier_Doppler_hz = (double)d_carrier_doppler_hz; | ||||
|             current_synchro_data.CN0_dB_hz = (double)d_CN0_SNV_dB_Hz; | ||||
|             *out[0] = current_synchro_data; | ||||
|  | ||||
|             // ########## DEBUG OUTPUT | ||||
|             /*! | ||||
|              *  \todo The stop timer has to be moved to the signal source! | ||||
| @@ -460,12 +466,8 @@ int galileo_e1_dll_pll_veml_tracking_cc::general_work (int noutput_items,gr_vect | ||||
|                     tmp_str_stream << "Tracking CH " << d_channel <<  ": Satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN) | ||||
|                                    << ", Doppler=" << d_carrier_doppler_hz << " [Hz] CN0 = " << d_CN0_SNV_dB_Hz << " [dB-Hz]" << std::endl; | ||||
|                     std::cout << tmp_str_stream.rdbuf() << std::flush; | ||||
|  | ||||
| 					//std::cout<<"TRK CH "<<d_channel<<" Carrier_lock_test="<<d_carrier_lock_test<< std::endl; | ||||
|                     //if (d_channel == 0 || d_last_seg==5) d_carrier_lock_fail_counter=500; //DEBUG: force unlock! | ||||
|                 } | ||||
|  | ||||
|  | ||||
|         } | ||||
|     else | ||||
|         { | ||||
| @@ -492,7 +494,6 @@ int galileo_e1_dll_pll_veml_tracking_cc::general_work (int noutput_items,gr_vect | ||||
|             tmp_P = std::abs<float>(*d_Prompt); | ||||
|             tmp_L = std::abs<float>(*d_Late); | ||||
|             tmp_VL = std::abs<float>(*d_Very_Late); | ||||
|             //std::cout<<"VE="<<tmp_VE<<",E="<<tmp_E<<",L="<<tmp_L<<",VL="<<tmp_VL<<std::endl; | ||||
|  | ||||
|             try | ||||
|             { | ||||
|   | ||||
| @@ -4,11 +4,6 @@ | ||||
|  *  Minus Late) tracking block for Galileo E1 signals | ||||
|  * \author Luis Esteve, 2012. luis(at)epsilon-formacion.com | ||||
|  * | ||||
|  * Code DLL + carrier PLL according to the algorithms described in: | ||||
|  * K.Borre, D.M.Akos, N.Bertelsen, P.Rinder, and S.H.Jensen, | ||||
|  * A Software-Defined GPS and Galileo Receiver. A Single-Frequency Approach, | ||||
|  * Birkhauser, 2007 | ||||
|  * | ||||
|  * ------------------------------------------------------------------------- | ||||
|  * | ||||
|  * Copyright (C) 2012  (see AUTHORS file for a list of contributors) | ||||
| @@ -42,19 +37,15 @@ | ||||
| #include <boost/thread/thread.hpp> | ||||
| #include <gnuradio/block.h> | ||||
| #include <gnuradio/msg_queue.h> | ||||
|  | ||||
| #include "concurrent_queue.h" | ||||
| #include "gnss_synchro.h" | ||||
| #include "tracking_2nd_DLL_filter.h" | ||||
| #include "tracking_2nd_PLL_filter.h" | ||||
| #include "correlator.h" | ||||
|  | ||||
|  | ||||
|  | ||||
| class galileo_e1_dll_pll_veml_tracking_cc; | ||||
|  | ||||
| typedef boost::shared_ptr<galileo_e1_dll_pll_veml_tracking_cc> | ||||
| galileo_e1_dll_pll_veml_tracking_cc_sptr; | ||||
| typedef boost::shared_ptr<galileo_e1_dll_pll_veml_tracking_cc> galileo_e1_dll_pll_veml_tracking_cc_sptr; | ||||
|  | ||||
| galileo_e1_dll_pll_veml_tracking_cc_sptr | ||||
| galileo_e1_dll_pll_veml_make_tracking_cc(long if_freq, | ||||
| @@ -72,11 +63,9 @@ galileo_e1_dll_pll_veml_make_tracking_cc(long if_freq, | ||||
|  * \brief This class implements a code DLL + carrier PLL VEML (Very Early | ||||
|  *  Minus Late) tracking block for Galileo E1 signals | ||||
|  */ | ||||
|  | ||||
| class galileo_e1_dll_pll_veml_tracking_cc: public gr::block | ||||
| { | ||||
| public: | ||||
|  | ||||
|     ~galileo_e1_dll_pll_veml_tracking_cc(); | ||||
|  | ||||
|     void set_channel(unsigned int channel); | ||||
| @@ -84,15 +73,17 @@ public: | ||||
|     void start_tracking(); | ||||
|     void set_channel_queue(concurrent_queue<int> *channel_internal_queue); | ||||
|  | ||||
|  | ||||
|     /*! | ||||
|      * \brief Code DLL + carrier PLL according to the algorithms described in: | ||||
|      * K.Borre, D.M.Akos, N.Bertelsen, P.Rinder, and S.H.Jensen, | ||||
|      * A Software-Defined GPS and Galileo Receiver. A Single-Frequency Approach, | ||||
|      * Birkhauser, 2007 | ||||
|      */ | ||||
|     int general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|             gr_vector_const_void_star &input_items, gr_vector_void_star &output_items); | ||||
|  | ||||
|     void forecast (int noutput_items, gr_vector_int &ninput_items_required); | ||||
|  | ||||
|  | ||||
| private: | ||||
|  | ||||
|     friend galileo_e1_dll_pll_veml_tracking_cc_sptr | ||||
|     galileo_e1_dll_pll_veml_make_tracking_cc(long if_freq, | ||||
|             long fs_in, unsigned | ||||
| @@ -196,7 +187,6 @@ private: | ||||
|  | ||||
|     std::map<std::string, std::string> systemName; | ||||
|     std::string sys; | ||||
|  | ||||
| }; | ||||
|  | ||||
| #endif //GNSS_SDR_GALILEO_E1_DLL_PLL_VEML_TRACKING_CC_H | ||||
|   | ||||
| @@ -49,11 +49,9 @@ | ||||
| #include <iostream> | ||||
| #include <sstream> | ||||
| #include <cmath> | ||||
| //#include "math.h" | ||||
| #include <gnuradio/io_signature.h> | ||||
| #include <glog/log_severity.h> | ||||
| #include <glog/logging.h> | ||||
|  | ||||
| #include <boost/asio.hpp> | ||||
| #include "tcp_packet_data.h" | ||||
|  | ||||
| @@ -67,8 +65,7 @@ | ||||
|  | ||||
| using google::LogMessage; | ||||
|  | ||||
| galileo_e1_tcp_connector_tracking_cc_sptr | ||||
| galileo_e1_tcp_connector_make_tracking_cc( | ||||
| galileo_e1_tcp_connector_tracking_cc_sptr galileo_e1_tcp_connector_make_tracking_cc( | ||||
|         long if_freq, | ||||
|         long fs_in, | ||||
|         unsigned int vector_length, | ||||
| @@ -92,6 +89,7 @@ void Galileo_E1_Tcp_Connector_Tracking_cc::forecast (int noutput_items, | ||||
|     ninput_items_required[0] = (int)d_vector_length*2; // set the required available samples in each call | ||||
| } | ||||
|  | ||||
|  | ||||
| Galileo_E1_Tcp_Connector_Tracking_cc::Galileo_E1_Tcp_Connector_Tracking_cc( | ||||
|         long if_freq, | ||||
|         long fs_in, | ||||
| @@ -152,7 +150,6 @@ Galileo_E1_Tcp_Connector_Tracking_cc::Galileo_E1_Tcp_Connector_Tracking_cc( | ||||
|     if (posix_memalign((void**)&d_Late, 16, sizeof(gr_complex)) == 0){}; | ||||
|     if (posix_memalign((void**)&d_Very_Late, 16, sizeof(gr_complex)) == 0){}; | ||||
|  | ||||
|  | ||||
|     //--- Perform initializations ------------------------------ | ||||
|     // define initial code frequency basis of NCO | ||||
|     d_code_freq_chips = Galileo_E1_CODE_CHIP_RATE_HZ; | ||||
| @@ -178,23 +175,24 @@ Galileo_E1_Tcp_Connector_Tracking_cc::Galileo_E1_Tcp_Connector_Tracking_cc( | ||||
|     d_CN0_SNV_dB_Hz = 0; | ||||
|     d_carrier_lock_fail_counter = 0; | ||||
|     d_carrier_lock_threshold = CARRIER_LOCK_THRESHOLD; | ||||
|  | ||||
|     systemName["G"] = std::string("GPS"); | ||||
|     systemName["R"] = std::string("GLONASS"); | ||||
|     systemName["S"] = std::string("SBAS"); | ||||
|     systemName["E"] = std::string("Galileo"); | ||||
|     systemName["C"] = std::string("Compass"); | ||||
| } | ||||
|  | ||||
|  | ||||
|  | ||||
| void Galileo_E1_Tcp_Connector_Tracking_cc::start_tracking() | ||||
| { | ||||
|     d_acq_code_phase_samples = d_acquisition_gnss_synchro->Acq_delay_samples; | ||||
|     d_acq_carrier_doppler_hz = d_acquisition_gnss_synchro->Acq_doppler_hz; | ||||
|     d_acq_sample_stamp =  d_acquisition_gnss_synchro->Acq_samplestamp_samples; | ||||
|  | ||||
|  | ||||
|     // generate local reference ALWAYS starting at chip 2 (2 samples per chip) | ||||
|     galileo_e1_code_gen_complex_sampled(&d_ca_code[2],d_acquisition_gnss_synchro->Signal, false, d_acquisition_gnss_synchro->PRN, 2*Galileo_E1_CODE_CHIP_RATE_HZ, 0); | ||||
|     galileo_e1_code_gen_complex_sampled(&d_ca_code[2], | ||||
|                                         d_acquisition_gnss_synchro->Signal, | ||||
|                                         false, | ||||
|                                         d_acquisition_gnss_synchro->PRN, | ||||
|                                         2*Galileo_E1_CODE_CHIP_RATE_HZ, | ||||
|                                         0); | ||||
|     // Fill head and tail | ||||
|     d_ca_code[0] = d_ca_code[(int)(2*Galileo_E1_B_CODE_LENGTH_CHIPS)]; | ||||
|     d_ca_code[1] = d_ca_code[(int)(2*Galileo_E1_B_CODE_LENGTH_CHIPS+1)]; | ||||
| @@ -215,7 +213,7 @@ void Galileo_E1_Tcp_Connector_Tracking_cc::start_tracking() | ||||
|  | ||||
|     // DEBUG OUTPUT | ||||
|     std::cout << "Tracking start on channel " << d_channel << " for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN) << std::endl; | ||||
|     DLOG(INFO) << "Start tracking for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN)  << " received" << std::endl; | ||||
|     DLOG(INFO) << "Start tracking for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN)  << " received"; | ||||
|  | ||||
|     // enable tracking | ||||
|     d_pull_in = true; | ||||
| @@ -262,12 +260,13 @@ void Galileo_E1_Tcp_Connector_Tracking_cc::update_local_code() | ||||
|     memcpy(d_very_late_code, &d_very_early_code[2*very_early_late_spc_samples], d_current_prn_length_samples* sizeof(gr_complex)); | ||||
| } | ||||
|  | ||||
|  | ||||
| void Galileo_E1_Tcp_Connector_Tracking_cc::update_local_carrier() | ||||
| { | ||||
|     float phase_rad, phase_step_rad; | ||||
|     // Compute the carrier phase step for the K-1 carrier doppler estimation | ||||
|     // Compute the carrier phase step for the K-1 carrier Doppler estimation | ||||
|     phase_step_rad = (float)GPS_TWO_PI*d_carrier_doppler_hz / (float)d_fs_in; | ||||
|     // Initialize the carrier phase with the remanent carrier phase of the K-2 loop | ||||
|     // Initialize the carrier phase with the remnant carrier phase of the K-2 loop | ||||
|     phase_rad = d_rem_carr_phase_rad; | ||||
|     for(int i = 0; i < d_current_prn_length_samples; i++) | ||||
|         { | ||||
| @@ -303,7 +302,6 @@ Galileo_E1_Tcp_Connector_Tracking_cc::~Galileo_E1_Tcp_Connector_Tracking_cc() | ||||
| int Galileo_E1_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|         gr_vector_const_void_star &input_items, gr_vector_void_star &output_items) | ||||
| { | ||||
|  | ||||
|     // process vars | ||||
|     float carr_error_filt_hz; | ||||
|     float code_error_filt_chips; | ||||
| @@ -328,7 +326,6 @@ int Galileo_E1_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_ve | ||||
|                     consume_each(samples_offset); //shift input to perform alignment with local replica | ||||
|                     return 1; | ||||
|                 } | ||||
|  | ||||
|             // GNSS_SYNCHRO OBJECT to interchange data between tracking->telemetry_decoder | ||||
|             Gnss_Synchro current_synchro_data; | ||||
|             // Fill the acquisition data | ||||
| @@ -363,7 +360,19 @@ int Galileo_E1_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_ve | ||||
|             d_control_id++; | ||||
|  | ||||
|             //! Send and receive a TCP packet | ||||
|             boost::array<float, NUM_TX_VARIABLES_GALILEO_E1> tx_variables_array = {{d_control_id,(*d_Very_Early).real(),(*d_Very_Early).imag(),(*d_Early).real(),(*d_Early).imag(),(*d_Late).real(),(*d_Late).imag(),(*d_Very_Late).real(),(*d_Very_Late).imag(),(*d_Prompt).real(),(*d_Prompt).imag(),d_acq_carrier_doppler_hz,1}}; | ||||
|             boost::array<float, NUM_TX_VARIABLES_GALILEO_E1> tx_variables_array = {{d_control_id, | ||||
|                                                                                     (*d_Very_Early).real(), | ||||
|                                                                                     (*d_Very_Early).imag(), | ||||
|                                                                                     (*d_Early).real(), | ||||
|                                                                                     (*d_Early).imag(), | ||||
|                                                                                     (*d_Late).real(), | ||||
|                                                                                     (*d_Late).imag(), | ||||
|                                                                                     (*d_Very_Late).real(), | ||||
|                                                                                     (*d_Very_Late).imag(), | ||||
|                                                                                     (*d_Prompt).real(), | ||||
|                                                                                     (*d_Prompt).imag(), | ||||
|                                                                                     d_acq_carrier_doppler_hz, | ||||
|                                                                                     1}}; | ||||
|             d_tcp_com.send_receive_tcp_packet_galileo_e1(tx_variables_array, &tcp_data); | ||||
|  | ||||
|             // ################## PLL ########################################################## | ||||
| @@ -375,7 +384,7 @@ int Galileo_E1_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_ve | ||||
|             d_code_freq_chips = Galileo_E1_CODE_CHIP_RATE_HZ + ((d_carrier_doppler_hz * Galileo_E1_CODE_CHIP_RATE_HZ) / Galileo_E1_FREQ_HZ); | ||||
|             //carrier phase accumulator for (K) doppler estimation | ||||
|             d_acc_carrier_phase_rad = d_acc_carrier_phase_rad + GPS_TWO_PI*d_carrier_doppler_hz*Galileo_E1_CODE_PERIOD; | ||||
|             //remanent carrier phase to prevent overflow in the code NCO | ||||
|             //remnant carrier phase to prevent overflow in the code NCO | ||||
|             d_rem_carr_phase_rad = d_rem_carr_phase_rad + GPS_TWO_PI*d_carrier_doppler_hz*Galileo_E1_CODE_PERIOD; | ||||
|             d_rem_carr_phase_rad = fmod(d_rem_carr_phase_rad, GPS_TWO_PI); | ||||
|  | ||||
| @@ -441,9 +450,7 @@ int Galileo_E1_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_ve | ||||
|                         } | ||||
|                 } | ||||
|  | ||||
|  | ||||
|             // ########### Output the tracking data to navigation and PVT ########## | ||||
|  | ||||
|             current_synchro_data.Prompt_I = (double)(*d_Prompt).real(); | ||||
|             current_synchro_data.Prompt_Q = (double)(*d_Prompt).imag(); | ||||
|             // Tracking_timestamp_secs is aligned with the PRN start sample | ||||
| @@ -475,7 +482,8 @@ int Galileo_E1_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_ve | ||||
|                     if (floor(d_sample_counter / d_fs_in) != d_last_seg) | ||||
|                         { | ||||
|                             d_last_seg = floor(d_sample_counter / d_fs_in); | ||||
|                             std::cout << "Tracking CH " << d_channel <<  ": Satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN) | ||||
|                             std::cout << "Tracking CH " << d_channel | ||||
|                                       <<  ": Satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN) | ||||
|                                       << ", CN0 = " << d_CN0_SNV_dB_Hz << " [dB-Hz]" << std::endl; | ||||
|                         } | ||||
|                 } | ||||
| @@ -554,9 +562,7 @@ int Galileo_E1_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_ve | ||||
|                     std::cout << "Exception writing trk dump file " << e.what() << std::endl; | ||||
|             } | ||||
|         } | ||||
| //    if(d_current_prn_length_samples!=d_vector_length) | ||||
| //    std::cout << "d_current_prn_length_samples = " << d_current_prn_length_samples << std::endl; | ||||
|     consume_each(d_current_prn_length_samples); // this is necesary in gr_block derivates | ||||
|     consume_each(d_current_prn_length_samples); // this is needed in gr::block derivates | ||||
|     d_sample_counter += d_current_prn_length_samples; //count for the processed samples | ||||
|     return 1; //output tracking result ALWAYS even in the case of d_enable_tracking==false | ||||
| } | ||||
| @@ -602,13 +608,12 @@ void Galileo_E1_Tcp_Connector_Tracking_cc::set_channel_queue(concurrent_queue<in | ||||
|     d_channel_internal_queue = channel_internal_queue; | ||||
| } | ||||
|  | ||||
|  | ||||
| void Galileo_E1_Tcp_Connector_Tracking_cc::set_gnss_synchro(Gnss_Synchro* p_gnss_synchro) | ||||
| { | ||||
|     d_acquisition_gnss_synchro = p_gnss_synchro; | ||||
|  | ||||
|     //  Gnss_Satellite(satellite.get_system(), satellite.get_PRN()); | ||||
|     //DLOG(INFO) << "Tracking code phase set to " << d_acq_code_phase_samples; | ||||
|     //DLOG(INFO) << "Tracking carrier doppler set to " << d_acq_carrier_doppler_hz; | ||||
|     //DLOG(INFO) << "Tracking Satellite set to " << d_satellite; | ||||
|  | ||||
| } | ||||
|   | ||||
| @@ -50,10 +50,9 @@ | ||||
| #include "tcp_communication.h" | ||||
|  | ||||
|  | ||||
|  | ||||
| class Galileo_E1_Tcp_Connector_Tracking_cc; | ||||
| typedef boost::shared_ptr<Galileo_E1_Tcp_Connector_Tracking_cc> | ||||
|         galileo_e1_tcp_connector_tracking_cc_sptr; | ||||
|  | ||||
| typedef boost::shared_ptr<Galileo_E1_Tcp_Connector_Tracking_cc> galileo_e1_tcp_connector_tracking_cc_sptr; | ||||
|  | ||||
| galileo_e1_tcp_connector_tracking_cc_sptr | ||||
| galileo_e1_tcp_connector_make_tracking_cc(long if_freq, | ||||
| @@ -75,7 +74,6 @@ galileo_e1_tcp_connector_make_tracking_cc(long if_freq, | ||||
| class Galileo_E1_Tcp_Connector_Tracking_cc: public gr::block | ||||
| { | ||||
| public: | ||||
|  | ||||
|     ~Galileo_E1_Tcp_Connector_Tracking_cc(); | ||||
|  | ||||
|     void set_channel(unsigned int channel); | ||||
| @@ -83,15 +81,11 @@ public: | ||||
|     void start_tracking(); | ||||
|     void set_channel_queue(concurrent_queue<int> *channel_internal_queue); | ||||
|  | ||||
|  | ||||
|     int general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|             gr_vector_const_void_star &input_items, gr_vector_void_star &output_items); | ||||
|  | ||||
|     void forecast (int noutput_items, gr_vector_int &ninput_items_required); | ||||
|  | ||||
|  | ||||
| private: | ||||
|  | ||||
|     friend galileo_e1_tcp_connector_tracking_cc_sptr | ||||
|     galileo_e1_tcp_connector_make_tracking_cc(long if_freq, | ||||
|             long fs_in, unsigned | ||||
|   | ||||
| @@ -36,7 +36,6 @@ | ||||
|  | ||||
| #include "gnss_synchro.h" | ||||
| #include "gps_l1_ca_dll_fll_pll_tracking_cc.h" | ||||
| //#include "gnss_signal_processing.h" | ||||
| #include "gps_sdr_signal_processing.h" | ||||
| #include "GPS_L1_CA.h" | ||||
| #include "tracking_discriminators.h" | ||||
| @@ -48,7 +47,6 @@ | ||||
| #include <iostream> | ||||
| #include <sstream> | ||||
| #include <cmath> | ||||
| //#include "math.h" | ||||
| #include <gnuradio/io_signature.h> | ||||
| #include <glog/log_severity.h> | ||||
| #include <glog/logging.h> | ||||
| @@ -65,8 +63,7 @@ | ||||
|  | ||||
| using google::LogMessage; | ||||
|  | ||||
| gps_l1_ca_dll_fll_pll_tracking_cc_sptr | ||||
| gps_l1_ca_dll_fll_pll_make_tracking_cc( | ||||
| gps_l1_ca_dll_fll_pll_tracking_cc_sptr gps_l1_ca_dll_fll_pll_make_tracking_cc( | ||||
|         long if_freq, | ||||
|         long fs_in, | ||||
|         unsigned | ||||
| @@ -142,7 +139,6 @@ Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc( | ||||
|     if (posix_memalign((void**)&d_prompt_code, 16, d_vector_length * sizeof(gr_complex) * 2) == 0){}; | ||||
|     // space for carrier wipeoff and signal baseband vectors | ||||
|     if (posix_memalign((void**)&d_carr_sign, 16, d_vector_length * sizeof(gr_complex) * 2) == 0){}; | ||||
|     // correlator outputs (scalar) | ||||
|     if (posix_memalign((void**)&d_Early, 16, sizeof(gr_complex)) == 0){}; | ||||
|     if (posix_memalign((void**)&d_Prompt, 16, sizeof(gr_complex)) == 0){}; | ||||
|     if (posix_memalign((void**)&d_Late, 16, sizeof(gr_complex)) == 0){}; | ||||
| @@ -151,11 +147,8 @@ Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc( | ||||
|     d_sample_counter = 0; | ||||
|     d_acq_sample_stamp = 0; | ||||
|     d_last_seg = 0;// this is for debug output only | ||||
|  | ||||
|     d_code_phase_samples = 0; | ||||
|  | ||||
|     d_enable_tracking = false; | ||||
|  | ||||
|     d_current_prn_length_samples = (int)d_vector_length; | ||||
|  | ||||
|     // CN0 estimation and lock detector buffers | ||||
| @@ -181,7 +174,6 @@ void Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::start_tracking() | ||||
|     /* | ||||
|      *  correct the code phase according to the delay between acq and trk | ||||
|      */ | ||||
|  | ||||
|     d_acq_code_phase_samples = d_acquisition_gnss_synchro->Acq_delay_samples; | ||||
|     d_acq_carrier_doppler_hz = d_acquisition_gnss_synchro->Acq_doppler_hz; | ||||
|     d_acq_sample_stamp =  d_acquisition_gnss_synchro->Acq_samplestamp_samples; | ||||
| @@ -253,11 +245,6 @@ void Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::start_tracking() | ||||
|     std::cout << "PULL-IN Doppler [Hz]= " << d_carrier_doppler_hz | ||||
|               << " Code Phase correction [samples]=" << delay_correction_samples | ||||
|               << " PULL-IN Code Phase [samples]= " << d_acq_code_phase_samples << std::endl; | ||||
|  | ||||
|  | ||||
|  | ||||
|  | ||||
|  | ||||
| } | ||||
|  | ||||
|  | ||||
| @@ -340,14 +327,10 @@ Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::~Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc() | ||||
|  | ||||
|  | ||||
|  | ||||
| /* Tracking signal processing | ||||
|  * Notice that this is a class derived from gr_sync_decimator, so each of the ninput_items has vector_length samples | ||||
|  */ | ||||
|  | ||||
| int Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|         gr_vector_const_void_star &input_items, gr_vector_void_star &output_items) | ||||
| { | ||||
|  | ||||
|     double code_error_chips = 0; | ||||
|     double code_error_filt_chips = 0; | ||||
|     double correlation_time_s = 0; | ||||
| @@ -395,7 +378,6 @@ int Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::general_work (int noutput_items, gr_vecto | ||||
|                     return 1; | ||||
|                 } | ||||
|  | ||||
|  | ||||
|             update_local_code(); | ||||
|             update_local_carrier(); | ||||
|  | ||||
| @@ -463,7 +445,6 @@ int Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::general_work (int noutput_items, gr_vecto | ||||
|             carr_nco_hz = d_carrier_loop_filter.get_carrier_error(d_FLL_discriminator_hz, PLL_discriminator_hz, correlation_time_s); | ||||
|             d_carrier_doppler_hz = d_if_freq + carr_nco_hz; | ||||
|  | ||||
|  | ||||
|             d_code_freq_hz = GPS_L1_CA_CODE_RATE_HZ + (((d_carrier_doppler_hz + d_if_freq) * GPS_L1_CA_CODE_RATE_HZ) / GPS_L1_FREQ_HZ); | ||||
|  | ||||
|             /*! | ||||
| @@ -496,7 +477,8 @@ int Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::general_work (int noutput_items, gr_vecto | ||||
|                         { | ||||
|                             std::cout << "Channel " << d_channel << " loss of lock!" << std::endl; | ||||
|                             ControlMessageFactory* cmf = new ControlMessageFactory(); | ||||
|                         	if (d_queue != gr::msg_queue::sptr()) { | ||||
|                             if (d_queue != gr::msg_queue::sptr()) | ||||
|                                 { | ||||
|                                     d_queue->handle(cmf->GetQueueMessage(d_channel, 2)); | ||||
|                                 } | ||||
|                             delete cmf; | ||||
| @@ -591,7 +573,6 @@ int Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::general_work (int noutput_items, gr_vecto | ||||
|                     d_dump_file.write((char*)&prompt_I, sizeof(float)); | ||||
|                     d_dump_file.write((char*)&prompt_Q, sizeof(float)); | ||||
|                     // PRN start sample stamp | ||||
|                     //tmp_float=(float)d_sample_counter; | ||||
|                     d_dump_file.write((char*)&d_sample_counter, sizeof(unsigned long int)); | ||||
|                     // accumulated carrier phase | ||||
|                     tmp_float = (float)d_acc_carrier_phase_rad; | ||||
| @@ -632,7 +613,7 @@ int Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc::general_work (int noutput_items, gr_vecto | ||||
|                     std::cout << "Exception writing trk dump file "<< e.what() << std::endl; | ||||
|             } | ||||
|         } | ||||
|     consume_each(d_current_prn_length_samples); // this is necesary in gr_block derivates | ||||
|     consume_each(d_current_prn_length_samples); // this is necessary in gr::block derivates | ||||
|     d_sample_counter += d_current_prn_length_samples; //count for the processed samples | ||||
|     return 1; //output tracking result ALWAYS even in the case of d_enable_tracking==false | ||||
| } | ||||
|   | ||||
| @@ -43,13 +43,11 @@ | ||||
| #include <boost/thread/thread.hpp> | ||||
| #include <gnuradio/block.h> | ||||
| #include <gnuradio/msg_queue.h> | ||||
| //#include <gnuradio/gr_sync_decimator.h> | ||||
| #include "concurrent_queue.h" | ||||
| #include "gps_sdr_signal_processing.h" | ||||
| #include "tracking_FLL_PLL_filter.h" | ||||
| #include "tracking_2nd_DLL_filter.h" | ||||
| #include "gnss_synchro.h" | ||||
| //#include "GPS_L1_CA.h" | ||||
| #include "correlator.h" | ||||
|  | ||||
| class Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc; | ||||
| @@ -71,7 +69,6 @@ gps_l1_ca_dll_fll_pll_make_tracking_cc( | ||||
|         float dll_bw_hz, | ||||
|         float early_late_space_chips); | ||||
|  | ||||
| //class gps_l1_ca_dll_pll_tracking_cc: public gr_sync_decimator | ||||
|  | ||||
| /*! | ||||
|  * \brief This class implements a DLL and a FLL assisted PLL tracking loop block | ||||
| @@ -79,7 +76,6 @@ gps_l1_ca_dll_fll_pll_make_tracking_cc( | ||||
| class Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc: public gr::block | ||||
| { | ||||
| public: | ||||
|  | ||||
|     ~Gps_L1_Ca_Dll_Fll_Pll_Tracking_cc(); | ||||
|  | ||||
|     void set_channel(unsigned int channel); | ||||
| @@ -103,10 +99,7 @@ public: | ||||
|             gr_vector_const_void_star &input_items, gr_vector_void_star &output_items); | ||||
|  | ||||
|     void forecast (int noutput_items, gr_vector_int &ninput_items_required); | ||||
|  | ||||
|  | ||||
| private: | ||||
|  | ||||
|     friend gps_l1_ca_dll_fll_pll_tracking_cc_sptr | ||||
|     gps_l1_ca_dll_fll_pll_make_tracking_cc( | ||||
|             long if_freq, | ||||
| @@ -163,7 +156,6 @@ private: | ||||
|  | ||||
|     double d_early_late_spc_chips; | ||||
|  | ||||
|  | ||||
|     double d_carrier_doppler_hz; | ||||
|     double d_code_freq_hz; | ||||
|     double d_code_phase_samples; | ||||
|   | ||||
| @@ -100,9 +100,6 @@ Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc( | ||||
|                   gr::io_signature::make(1, 1, sizeof(gr_complex)), | ||||
|                   gr::io_signature::make(1, 1, sizeof(Gnss_Synchro))) | ||||
| { | ||||
|  | ||||
|     //gr_sync_decimator ("Gps_L1_Ca_Dll_Pll_Tracking_cc", gr_make_io_signature (1, 1, sizeof(gr_complex)), | ||||
|     //		gr_make_io_signature(3, 3, sizeof(float)),vector_length) { | ||||
|     // initialize internal vars | ||||
|     d_queue = queue; | ||||
|     d_dump = dump; | ||||
| @@ -113,7 +110,6 @@ Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc( | ||||
|     d_dump_filename = dump_filename; | ||||
|  | ||||
|     // Initialize tracking  ========================================== | ||||
|  | ||||
|     d_code_loop_filter.set_DLL_BW(dll_bw_hz); | ||||
|     d_carrier_loop_filter.set_PLL_BW(pll_bw_hz); | ||||
|  | ||||
| @@ -124,12 +120,12 @@ Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc( | ||||
|     // Get space for a vector with the C/A code replica sampled 1x/chip | ||||
|     d_ca_code = new gr_complex[(int)GPS_L1_CA_CODE_LENGTH_CHIPS + 2]; | ||||
|  | ||||
|  | ||||
|     /* If an array is partitioned for more than one thread to operate on, | ||||
|      * having the sub-array boundaries unaligned to cache lines could lead | ||||
|      * to performance degradation. Here we allocate memory | ||||
|      * (gr_comlex array of size 2*d_vector_length) aligned to cache of 16 bytes | ||||
|      */ | ||||
|  | ||||
|     // todo: do something if posix_memalign fails | ||||
|     // Get space for the resampled early / prompt / late local replicas | ||||
|     if (posix_memalign((void**)&d_early_code, 16, d_vector_length * sizeof(gr_complex) * 2) == 0){}; | ||||
| @@ -137,12 +133,10 @@ Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc( | ||||
|     if (posix_memalign((void**)&d_prompt_code, 16, d_vector_length * sizeof(gr_complex) * 2) == 0){}; | ||||
|     // space for carrier wipeoff and signal baseband vectors | ||||
|     if (posix_memalign((void**)&d_carr_sign, 16, d_vector_length * sizeof(gr_complex) * 2) == 0){}; | ||||
|     // correlator outputs (scalar) | ||||
|     if (posix_memalign((void**)&d_Early, 16, sizeof(gr_complex)) == 0){}; | ||||
|     if (posix_memalign((void**)&d_Prompt, 16, sizeof(gr_complex)) == 0){}; | ||||
|     if (posix_memalign((void**)&d_Late, 16, sizeof(gr_complex)) == 0){}; | ||||
|  | ||||
|  | ||||
|     //--- Perform initializations ------------------------------ | ||||
|     // define initial code frequency basis of NCO | ||||
|     d_code_freq_chips = GPS_L1_CA_CODE_RATE_HZ; | ||||
| @@ -177,12 +171,10 @@ Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc( | ||||
|     systemName["C"] = std::string("Compass"); | ||||
| } | ||||
|  | ||||
|  | ||||
| void Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::start_tracking() | ||||
| { | ||||
|     /* | ||||
|      *  correct the code phase according to the delay between acq and trk | ||||
|      */ | ||||
|  | ||||
|     // correct the code phase according to the delay between acq and trk | ||||
|     d_acq_code_phase_samples = d_acquisition_gnss_synchro->Acq_delay_samples; | ||||
|     d_acq_carrier_doppler_hz = d_acquisition_gnss_synchro->Acq_doppler_hz; | ||||
|     d_acq_sample_stamp = d_acquisition_gnss_synchro->Acq_samplestamp_samples; | ||||
| @@ -204,7 +196,6 @@ void Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::start_tracking() | ||||
|     T_chip_mod_seconds = 1/d_code_freq_chips; | ||||
|     T_prn_mod_seconds = T_chip_mod_seconds * GPS_L1_CA_CODE_LENGTH_CHIPS; | ||||
|     T_prn_mod_samples = T_prn_mod_seconds * (float)d_fs_in; | ||||
|  | ||||
|     d_current_prn_length_samples = round(T_prn_mod_samples); | ||||
|  | ||||
|     float T_prn_true_seconds = GPS_L1_CA_CODE_LENGTH_CHIPS / GPS_L1_CA_CODE_RATE_HZ; | ||||
| @@ -220,10 +211,9 @@ void Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::start_tracking() | ||||
|             corrected_acq_phase_samples = T_prn_mod_samples + corrected_acq_phase_samples; | ||||
|         } | ||||
|     delay_correction_samples = d_acq_code_phase_samples - corrected_acq_phase_samples; | ||||
|  | ||||
|     d_acq_code_phase_samples = corrected_acq_phase_samples; | ||||
|  | ||||
|     d_carrier_doppler_hz = d_acq_carrier_doppler_hz; | ||||
|  | ||||
|     // DLL/PLL filter initialization | ||||
|     d_carrier_loop_filter.initialize(); //initialize the carrier filter | ||||
|     d_code_loop_filter.initialize();    //initialize the code filter | ||||
| @@ -233,11 +223,9 @@ void Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::start_tracking() | ||||
|     d_ca_code[0] = d_ca_code[(int)GPS_L1_CA_CODE_LENGTH_CHIPS]; | ||||
|     d_ca_code[(int)GPS_L1_CA_CODE_LENGTH_CHIPS + 1] = d_ca_code[1]; | ||||
|  | ||||
|  | ||||
|     //****************************************************************************** | ||||
|     // Experimental: pre-sampled local signal replica at nominal code frequency. | ||||
|     // No code doppler correction | ||||
|  | ||||
|     double tcode_chips; | ||||
|     int associated_chip_index; | ||||
|     int code_length_chips = (int)GPS_L1_CA_CODE_LENGTH_CHIPS; | ||||
| @@ -261,7 +249,6 @@ void Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::start_tracking() | ||||
|  | ||||
|     memcpy(d_prompt_code, &d_early_code[early_late_spc_samples], d_current_prn_length_samples* sizeof(gr_complex)); | ||||
|     memcpy(d_late_code, &d_early_code[early_late_spc_samples*2], d_current_prn_length_samples* sizeof(gr_complex)); | ||||
|  | ||||
|     //****************************************************************************** | ||||
|  | ||||
|     d_carrier_lock_fail_counter = 0; | ||||
| @@ -327,6 +314,7 @@ void Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::update_local_carrier() | ||||
|     //sse_nco(d_carr_sign, d_current_prn_length_samples,d_rem_carr_phase_rad, phase_step_rad); | ||||
| } | ||||
|  | ||||
|  | ||||
| Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::~Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc() | ||||
| { | ||||
|     d_dump_file.close(); | ||||
| @@ -344,17 +332,12 @@ Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::~Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc() | ||||
| } | ||||
|  | ||||
|  | ||||
| /* Tracking signal processing | ||||
|  * Notice that this is a class derived from gr_sync_decimator, so each of the ninput_items has vector_length samples | ||||
|  */ | ||||
|  | ||||
| // Tracking signal processing | ||||
| int Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|         gr_vector_const_void_star &input_items, gr_vector_void_star &output_items) | ||||
| { | ||||
|     // stream to collect cout calls to improve thread safety | ||||
|     std::stringstream tmp_str_stream; | ||||
|  | ||||
|  | ||||
|     float carr_error_hz; | ||||
|     float carr_error_filt_hz; | ||||
|     float code_error_chips; | ||||
| @@ -368,20 +351,14 @@ int Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::general_work (int noutput_items, gr_vec | ||||
|             if (d_pull_in == true) | ||||
|                 { | ||||
|                     int samples_offset; | ||||
|  | ||||
|                     // 28/11/2011 ACQ to TRK transition BUG CORRECTION | ||||
|                     float acq_trk_shif_correction_samples; | ||||
|                     int acq_to_trk_delay_samples; | ||||
|                     acq_to_trk_delay_samples = d_sample_counter - d_acq_sample_stamp; | ||||
|                     acq_trk_shif_correction_samples = d_current_prn_length_samples - fmod((float)acq_to_trk_delay_samples, (float)d_current_prn_length_samples); | ||||
|                     //std::cout<<"acq_trk_shif_correction="<<acq_trk_shif_correction_samples<<"\r\n"; | ||||
|                     samples_offset = round(d_acq_code_phase_samples + acq_trk_shif_correction_samples); | ||||
|                     // /todo: Check if the sample counter sent to the next block as a time reference should be incremented AFTER sended or BEFORE | ||||
|                     //d_sample_counter_seconds = d_sample_counter_seconds + (((double)samples_offset) / (double)d_fs_in); | ||||
|                     d_sample_counter = d_sample_counter + samples_offset; //count for the processed samples | ||||
|                     d_pull_in = false; | ||||
|                     //std::cout<<" samples_offset="<<samples_offset<<"\r\n"; | ||||
|                     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; | ||||
|                 } | ||||
|             // GNSS_SYNCHRO OBJECT to interchange data between tracking->telemetry_decoder | ||||
| @@ -390,13 +367,11 @@ int Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::general_work (int noutput_items, gr_vec | ||||
|             current_synchro_data = *d_acquisition_gnss_synchro; | ||||
|  | ||||
|             // Block input data and block output stream pointers | ||||
|             const gr_complex* in = (gr_complex*) input_items[0]; //PRN start block alignement | ||||
|             const gr_complex* in = (gr_complex*) input_items[0]; //PRN start block alignment | ||||
|             Gnss_Synchro **out = (Gnss_Synchro **) &output_items[0]; | ||||
|  | ||||
|             // Generate local code and carrier replicas (using \hat{f}_d(k-1)) | ||||
|  | ||||
|             //update_local_code(); //disabled in the speed optimized tracking! | ||||
|  | ||||
|             update_local_carrier(); | ||||
|  | ||||
|             // perform Early, Prompt and Late correlation | ||||
| @@ -436,7 +411,6 @@ int Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::general_work (int noutput_items, gr_vec | ||||
|             code_error_filt_secs = (GPS_L1_CA_CODE_PERIOD*code_error_filt_chips) / GPS_L1_CA_CODE_RATE_HZ; //[seconds] | ||||
|             d_acc_code_phase_secs = d_acc_code_phase_secs + code_error_filt_secs; | ||||
|  | ||||
|  | ||||
|             // ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT ####################### | ||||
|             // keep alignment parameters for the next input buffer | ||||
|             float T_chip_seconds; | ||||
| @@ -451,7 +425,6 @@ int Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::general_work (int noutput_items, gr_vec | ||||
|             d_current_prn_length_samples = round(K_blk_samples); //round to a discrete samples | ||||
|             d_rem_code_phase_samples = K_blk_samples - d_current_prn_length_samples; //rounding error < 1 sample | ||||
|  | ||||
|  | ||||
|             // ####### CN0 ESTIMATION AND LOCK DETECTORS ###### | ||||
|             if (d_cn0_estimation_counter < CN0_ESTIMATION_SAMPLES) | ||||
|                 { | ||||
| @@ -489,7 +462,6 @@ int Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::general_work (int noutput_items, gr_vec | ||||
|                         } | ||||
|                 } | ||||
|             // ########### Output the tracking data to navigation and PVT ########## | ||||
|  | ||||
|             current_synchro_data.Prompt_I = (double)(*d_Prompt).real(); | ||||
|             current_synchro_data.Prompt_Q = (double)(*d_Prompt).imag(); | ||||
|             // Tracking_timestamp_secs is aligned with the PRN start sample | ||||
| @@ -519,8 +491,7 @@ int Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc::general_work (int noutput_items, gr_vec | ||||
|                     tmp_str_stream << "Tracking CH " << d_channel <<  ": Satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN) | ||||
|                                    << ", Doppler=" << d_carrier_doppler_hz << " [Hz] CN0 = " << d_CN0_SNV_dB_Hz << " [dB-Hz]" << std::endl; | ||||
|                     std::cout << tmp_str_stream.rdbuf() << std::flush; | ||||
|  | ||||
| 					//std::cout<<"TRK CH "<<d_channel<<" Carrier_lock_test="<<d_carrier_lock_test<< std::endl; | ||||
|                     LOG(INFO) << tmp_str_stream.rdbuf(); | ||||
|                     //if (d_channel == 0 || d_last_seg==5) d_carrier_lock_fail_counter=500; //DEBUG: force unlock! | ||||
|                 } | ||||
|         } | ||||
|   | ||||
| @@ -43,25 +43,20 @@ | ||||
| #include <boost/thread/thread.hpp> | ||||
| #include <gnuradio/block.h> | ||||
| #include <gnuradio/msg_queue.h> | ||||
| //#include <gnuradio/gr_sync_decimator.h> | ||||
| #include "concurrent_queue.h" | ||||
| #include "gps_sdr_signal_processing.h" | ||||
| #include "gnss_synchro.h" | ||||
| #include "tracking_2nd_DLL_filter.h" | ||||
| #include "tracking_2nd_PLL_filter.h" | ||||
|  | ||||
| #include "correlator.h" | ||||
|  | ||||
|  | ||||
|  | ||||
| class Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc; | ||||
| typedef boost::shared_ptr<Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc> | ||||
| 	gps_l1_ca_dll_pll_optim_tracking_cc_sptr; | ||||
|  | ||||
| gps_l1_ca_dll_pll_optim_tracking_cc_sptr | ||||
| gps_l1_ca_dll_pll_make_optim_tracking_cc(long if_freq, | ||||
|                                    long fs_in, unsigned | ||||
|                                    int vector_length, | ||||
| typedef boost::shared_ptr<Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc> gps_l1_ca_dll_pll_optim_tracking_cc_sptr; | ||||
|  | ||||
| gps_l1_ca_dll_pll_optim_tracking_cc_sptr gps_l1_ca_dll_pll_make_optim_tracking_cc(long if_freq, | ||||
|                                                                                   long fs_in, | ||||
|                                                                                   unsigned int vector_length, | ||||
|                                                                                   boost::shared_ptr<gr::msg_queue> queue, | ||||
|                                                                                   bool dump, | ||||
|                                                                                   std::string dump_filename, | ||||
| @@ -69,7 +64,6 @@ gps_l1_ca_dll_pll_make_optim_tracking_cc(long if_freq, | ||||
|                                                                                   float dll_bw_hz, | ||||
|                                                                                   float early_late_space_chips); | ||||
|  | ||||
| //class gps_l1_ca_dll_pll_tracking_cc: public gr_sync_decimator | ||||
|  | ||||
| /*! | ||||
|  * \brief This class implements a DLL + PLL tracking loop block | ||||
| @@ -77,7 +71,6 @@ gps_l1_ca_dll_pll_make_optim_tracking_cc(long if_freq, | ||||
| class Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc: public gr::block | ||||
| { | ||||
| public: | ||||
|  | ||||
|     ~Gps_L1_Ca_Dll_Pll_Optim_Tracking_cc(); | ||||
|  | ||||
|     void set_channel(unsigned int channel); | ||||
| @@ -85,20 +78,11 @@ public: | ||||
|     void start_tracking(); | ||||
|     void set_channel_queue(concurrent_queue<int> *channel_internal_queue); | ||||
|  | ||||
|     /* | ||||
|      * \brief just like gr_block::general_work, only this arranges to call consume_each for you | ||||
|      * | ||||
|      * The user must override work to define the signal processing code | ||||
|      */ | ||||
|  | ||||
|     int general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|             gr_vector_const_void_star &input_items, gr_vector_void_star &output_items); | ||||
|  | ||||
|     void forecast (int noutput_items, gr_vector_int &ninput_items_required); | ||||
|  | ||||
|  | ||||
| private: | ||||
|  | ||||
|     friend gps_l1_ca_dll_pll_optim_tracking_cc_sptr | ||||
|     gps_l1_ca_dll_pll_make_optim_tracking_cc(long if_freq, | ||||
|             long fs_in, unsigned | ||||
|   | ||||
| @@ -45,7 +45,6 @@ | ||||
| #include <iostream> | ||||
| #include <sstream> | ||||
| #include <cmath> | ||||
| //#include "math.h" | ||||
| #include <gnuradio/io_signature.h> | ||||
| #include <glog/log_severity.h> | ||||
| #include <glog/logging.h> | ||||
| @@ -100,9 +99,6 @@ Gps_L1_Ca_Dll_Pll_Tracking_cc::Gps_L1_Ca_Dll_Pll_Tracking_cc( | ||||
|         gr::block("Gps_L1_Ca_Dll_Pll_Tracking_cc", gr::io_signature::make(1, 1, sizeof(gr_complex)), | ||||
|                 gr::io_signature::make(1, 1, sizeof(Gnss_Synchro))) | ||||
| { | ||||
|  | ||||
|     //gr_sync_decimator ("Gps_L1_Ca_Dll_Pll_Tracking_cc", gr_make_io_signature (1, 1, sizeof(gr_complex)), | ||||
|     //		gr_make_io_signature(3, 3, sizeof(float)),vector_length) { | ||||
|     // initialize internal vars | ||||
|     d_queue = queue; | ||||
|     d_dump = dump; | ||||
| @@ -112,7 +108,6 @@ Gps_L1_Ca_Dll_Pll_Tracking_cc::Gps_L1_Ca_Dll_Pll_Tracking_cc( | ||||
|     d_dump_filename = dump_filename; | ||||
|  | ||||
|     // Initialize tracking  ========================================== | ||||
|  | ||||
|     d_code_loop_filter.set_DLL_BW(dll_bw_hz); | ||||
|     d_carrier_loop_filter.set_PLL_BW(pll_bw_hz); | ||||
|  | ||||
| @@ -135,12 +130,10 @@ Gps_L1_Ca_Dll_Pll_Tracking_cc::Gps_L1_Ca_Dll_Pll_Tracking_cc( | ||||
|     if (posix_memalign((void**)&d_prompt_code, 16, d_vector_length * sizeof(gr_complex) * 2) == 0){}; | ||||
|     // space for carrier wipeoff and signal baseband vectors | ||||
|     if (posix_memalign((void**)&d_carr_sign, 16, d_vector_length * sizeof(gr_complex) * 2) == 0){}; | ||||
|     // correlator outputs (scalar) | ||||
|     if (posix_memalign((void**)&d_Early, 16, sizeof(gr_complex)) == 0){}; | ||||
|     if (posix_memalign((void**)&d_Prompt, 16, sizeof(gr_complex)) == 0){}; | ||||
|     if (posix_memalign((void**)&d_Late, 16, sizeof(gr_complex)) == 0){}; | ||||
|  | ||||
|  | ||||
|     //--- Perform initializations ------------------------------ | ||||
|     // define initial code frequency basis of NCO | ||||
|     d_code_freq_chips = GPS_L1_CA_CODE_RATE_HZ; | ||||
| @@ -175,12 +168,12 @@ Gps_L1_Ca_Dll_Pll_Tracking_cc::Gps_L1_Ca_Dll_Pll_Tracking_cc( | ||||
|     systemName["C"] = std::string("Compass"); | ||||
| } | ||||
|  | ||||
|  | ||||
| void Gps_L1_Ca_Dll_Pll_Tracking_cc::start_tracking() | ||||
| { | ||||
|     /* | ||||
|      *  correct the code phase according to the delay between acq and trk | ||||
|      */ | ||||
|  | ||||
|     d_acq_code_phase_samples = d_acquisition_gnss_synchro->Acq_delay_samples; | ||||
|     d_acq_carrier_doppler_hz = d_acquisition_gnss_synchro->Acq_doppler_hz; | ||||
|     d_acq_sample_stamp =  d_acquisition_gnss_synchro->Acq_samplestamp_samples; | ||||
| @@ -222,6 +215,7 @@ void Gps_L1_Ca_Dll_Pll_Tracking_cc::start_tracking() | ||||
|     d_acq_code_phase_samples = corrected_acq_phase_samples; | ||||
|  | ||||
|     d_carrier_doppler_hz = d_acq_carrier_doppler_hz; | ||||
|  | ||||
|     // DLL/PLL filter initialization | ||||
|     d_carrier_loop_filter.initialize(); // initialize the carrier filter | ||||
|     d_code_loop_filter.initialize();    // initialize the code filter | ||||
| @@ -244,7 +238,7 @@ void Gps_L1_Ca_Dll_Pll_Tracking_cc::start_tracking() | ||||
|  | ||||
|     // DEBUG OUTPUT | ||||
|     std::cout << "Tracking start on channel " << d_channel << " for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN) << std::endl; | ||||
|     DLOG(INFO) << "Start tracking for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN)  << " received" << std::endl; | ||||
|     DLOG(INFO) << "Start tracking for satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN)  << " received"; | ||||
|  | ||||
|     // enable tracking | ||||
|     d_pull_in = true; | ||||
| @@ -326,14 +320,10 @@ Gps_L1_Ca_Dll_Pll_Tracking_cc::~Gps_L1_Ca_Dll_Pll_Tracking_cc() | ||||
| } | ||||
|  | ||||
|  | ||||
| /* Tracking signal processing | ||||
|  * Notice that this is a class derived from gr_sync_decimator, so each of the ninput_items has vector_length samples | ||||
|  */ | ||||
|  | ||||
| int Gps_L1_Ca_Dll_Pll_Tracking_cc::general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|         gr_vector_const_void_star &input_items, gr_vector_void_star &output_items) | ||||
| { | ||||
|  | ||||
|     // process vars | ||||
|     float carr_error_hz; | ||||
|     float carr_error_filt_hz; | ||||
| @@ -342,26 +332,21 @@ int Gps_L1_Ca_Dll_Pll_Tracking_cc::general_work (int noutput_items, gr_vector_in | ||||
|  | ||||
|     if (d_enable_tracking == true) | ||||
|         { | ||||
|             /* | ||||
|              * Receiver signal alignment | ||||
|              */ | ||||
|             // Receiver signal alignment | ||||
|             if (d_pull_in == true) | ||||
|                 { | ||||
|                     int samples_offset; | ||||
|  | ||||
|                     // 28/11/2011 ACQ to TRK transition BUG CORRECTION | ||||
|                     float acq_trk_shif_correction_samples; | ||||
|                     int acq_to_trk_delay_samples; | ||||
|                     acq_to_trk_delay_samples = d_sample_counter - d_acq_sample_stamp; | ||||
|                     acq_trk_shif_correction_samples = d_current_prn_length_samples - fmod((float)acq_to_trk_delay_samples, (float)d_current_prn_length_samples); | ||||
|                     //std::cout<<"acq_trk_shif_correction="<<acq_trk_shif_correction_samples<<"\r\n"; | ||||
|                     samples_offset = round(d_acq_code_phase_samples + acq_trk_shif_correction_samples); | ||||
|                     // /todo: Check if the sample counter sent to the next block as a time reference should be incremented AFTER sended or BEFORE | ||||
|                     //d_sample_counter_seconds = d_sample_counter_seconds + (((double)samples_offset) / (double)d_fs_in); | ||||
|                     d_sample_counter = d_sample_counter + samples_offset; //count for the processed samples | ||||
|                     d_pull_in = false; | ||||
|                     //std::cout<<" samples_offset="<<samples_offset<<"\r\n"; | ||||
|                     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; | ||||
|                 } | ||||
|  | ||||
| @@ -371,7 +356,7 @@ int Gps_L1_Ca_Dll_Pll_Tracking_cc::general_work (int noutput_items, gr_vector_in | ||||
|             current_synchro_data = *d_acquisition_gnss_synchro; | ||||
|  | ||||
|             // Block input data and block output stream pointers | ||||
|             const gr_complex* in = (gr_complex*) input_items[0]; //PRN start block alignement | ||||
|             const gr_complex* in = (gr_complex*) input_items[0]; //PRN start block alignment | ||||
|             Gnss_Synchro **out = (Gnss_Synchro **) &output_items[0]; | ||||
|  | ||||
|             // Generate local code and carrier replicas (using \hat{f}_d(k-1)) | ||||
| @@ -437,14 +422,13 @@ int Gps_L1_Ca_Dll_Pll_Tracking_cc::general_work (int noutput_items, gr_vector_in | ||||
|             code_error_filt_secs = (GPS_L1_CA_CODE_PERIOD*code_error_filt_chips)/GPS_L1_CA_CODE_RATE_HZ; //[seconds] | ||||
|             d_acc_code_phase_secs = d_acc_code_phase_secs + code_error_filt_secs; | ||||
|  | ||||
|  | ||||
|             // ################## CARRIER AND CODE NCO BUFFER ALIGNEMENT ####################### | ||||
|             // keep alignment parameters for the next input buffer | ||||
|             float T_chip_seconds; | ||||
|             float T_prn_seconds; | ||||
|             float T_prn_samples; | ||||
|             float 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 / d_code_freq_chips; | ||||
|             T_prn_seconds = T_chip_seconds * GPS_L1_CA_CODE_LENGTH_CHIPS; | ||||
|             T_prn_samples = T_prn_seconds * (float)d_fs_in; | ||||
| @@ -452,7 +436,6 @@ int Gps_L1_Ca_Dll_Pll_Tracking_cc::general_work (int noutput_items, gr_vector_in | ||||
|             d_current_prn_length_samples = round(K_blk_samples); //round to a discrete samples | ||||
|             d_rem_code_phase_samples = K_blk_samples - d_current_prn_length_samples; //rounding error < 1 sample | ||||
|  | ||||
|  | ||||
|             // ####### CN0 ESTIMATION AND LOCK DETECTORS ###### | ||||
|             if (d_cn0_estimation_counter < CN0_ESTIMATION_SAMPLES) | ||||
|                 { | ||||
| @@ -490,7 +473,6 @@ int Gps_L1_Ca_Dll_Pll_Tracking_cc::general_work (int noutput_items, gr_vector_in | ||||
|                         } | ||||
|                 } | ||||
|             // ########### Output the tracking data to navigation and PVT ########## | ||||
|  | ||||
|             current_synchro_data.Prompt_I = (double)(*d_Prompt).real(); | ||||
|             current_synchro_data.Prompt_Q = (double)(*d_Prompt).imag(); | ||||
|             // Tracking_timestamp_secs is aligned with the PRN start sample | ||||
| @@ -515,7 +497,6 @@ int Gps_L1_Ca_Dll_Pll_Tracking_cc::general_work (int noutput_items, gr_vector_in | ||||
|                             std::cout << "Current input signal time = " << d_last_seg << " [s]" << std::endl; | ||||
|                             std::cout << "Tracking CH " << d_channel <<  ": Satellite " << Gnss_Satellite(systemName[sys], d_acquisition_gnss_synchro->PRN) | ||||
|                                       << ", CN0 = " << d_CN0_SNV_dB_Hz << " [dB-Hz]" << std::endl; | ||||
|                             //std::cout<<"TRK CH "<<d_channel<<" Carrier_lock_test="<<d_carrier_lock_test<< std::endl; | ||||
|                             //if (d_last_seg==5) d_carrier_lock_fail_counter=500; //DEBUG: force unlock! | ||||
|                         } | ||||
|                 } | ||||
| @@ -596,7 +577,7 @@ int Gps_L1_Ca_Dll_Pll_Tracking_cc::general_work (int noutput_items, gr_vector_in | ||||
|             } | ||||
|         } | ||||
|  | ||||
|     consume_each(d_current_prn_length_samples); // this is necesary in gr_block derivates | ||||
|     consume_each(d_current_prn_length_samples); // this is necessary in gr::block derivates | ||||
|     d_sample_counter += d_current_prn_length_samples; //count for the processed samples | ||||
|     return 1; //output tracking result ALWAYS even in the case of d_enable_tracking==false | ||||
| } | ||||
|   | ||||
| @@ -42,17 +42,13 @@ | ||||
| #include <boost/thread/thread.hpp> | ||||
| #include <gnuradio/block.h> | ||||
| #include <gnuradio/msg_queue.h> | ||||
| //#include <gnuradio/gr_sync_decimator.h> | ||||
| #include "concurrent_queue.h" | ||||
| #include "gps_sdr_signal_processing.h" | ||||
| #include "gnss_synchro.h" | ||||
| #include "tracking_2nd_DLL_filter.h" | ||||
| #include "tracking_2nd_PLL_filter.h" | ||||
|  | ||||
| #include "correlator.h" | ||||
|  | ||||
|  | ||||
|  | ||||
| class Gps_L1_Ca_Dll_Pll_Tracking_cc; | ||||
|  | ||||
| typedef boost::shared_ptr<Gps_L1_Ca_Dll_Pll_Tracking_cc> | ||||
| @@ -69,7 +65,7 @@ gps_l1_ca_dll_pll_make_tracking_cc(long if_freq, | ||||
|                                    float dll_bw_hz, | ||||
|                                    float early_late_space_chips); | ||||
|  | ||||
| //class gps_l1_ca_dll_pll_tracking_cc: public gr_sync_decimator | ||||
|  | ||||
|  | ||||
| /*! | ||||
|  * \brief This class implements a DLL + PLL tracking loop block | ||||
| @@ -77,7 +73,6 @@ gps_l1_ca_dll_pll_make_tracking_cc(long if_freq, | ||||
| class Gps_L1_Ca_Dll_Pll_Tracking_cc: public gr::block | ||||
| { | ||||
| public: | ||||
|  | ||||
|     ~Gps_L1_Ca_Dll_Pll_Tracking_cc(); | ||||
|  | ||||
|     void set_channel(unsigned int channel); | ||||
| @@ -85,20 +80,12 @@ public: | ||||
|     void start_tracking(); | ||||
|     void set_channel_queue(concurrent_queue<int> *channel_internal_queue); | ||||
|  | ||||
|     /* | ||||
|      * \brief just like gr_block::general_work, only this arranges to call consume_each for you | ||||
|      * | ||||
|      * The user must override work to define the signal processing code | ||||
|      */ | ||||
|  | ||||
|     int general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|             gr_vector_const_void_star &input_items, gr_vector_void_star &output_items); | ||||
|  | ||||
|     void forecast (int noutput_items, gr_vector_int &ninput_items_required); | ||||
|  | ||||
|  | ||||
| private: | ||||
|  | ||||
|     friend gps_l1_ca_dll_pll_tracking_cc_sptr | ||||
|     gps_l1_ca_dll_pll_make_tracking_cc(long if_freq, | ||||
|             long fs_in, unsigned | ||||
|   | ||||
| @@ -47,7 +47,6 @@ | ||||
| #include <iostream> | ||||
| #include <sstream> | ||||
| #include <cmath> | ||||
| //#include "math.h" | ||||
| #include <gnuradio/io_signature.h> | ||||
| #include <glog/log_severity.h> | ||||
| #include <glog/logging.h> | ||||
| @@ -105,9 +104,6 @@ Gps_L1_Ca_Tcp_Connector_Tracking_cc::Gps_L1_Ca_Tcp_Connector_Tracking_cc( | ||||
|         gr::block("Gps_L1_Ca_Tcp_Connector_Tracking_cc", gr::io_signature::make(1, 1, sizeof(gr_complex)), | ||||
|                 gr::io_signature::make(1, 1, sizeof(Gnss_Synchro))) | ||||
| { | ||||
|  | ||||
|     //gr_sync_decimator ("Gps_L1_Ca_Tcp_Connector_Tracking_cc", gr_make_io_signature (1, 1, sizeof(gr_complex)), | ||||
|     //		gr_make_io_signature(3, 3, sizeof(float)),vector_length) { | ||||
|     // initialize internal vars | ||||
|     d_queue = queue; | ||||
|     d_dump = dump; | ||||
| @@ -117,7 +113,6 @@ Gps_L1_Ca_Tcp_Connector_Tracking_cc::Gps_L1_Ca_Tcp_Connector_Tracking_cc( | ||||
|     d_dump_filename = dump_filename; | ||||
|  | ||||
|     // Initialize tracking  ========================================== | ||||
|  | ||||
|     d_code_loop_filter.set_DLL_BW(dll_bw_hz); | ||||
|     d_carrier_loop_filter.set_PLL_BW(pll_bw_hz); | ||||
|  | ||||
| @@ -133,9 +128,6 @@ Gps_L1_Ca_Tcp_Connector_Tracking_cc::Gps_L1_Ca_Tcp_Connector_Tracking_cc( | ||||
|     // Initialization of local code replica | ||||
|     // Get space for a vector with the C/A code replica sampled 1x/chip | ||||
|     d_ca_code = new gr_complex[(int)GPS_L1_CA_CODE_LENGTH_CHIPS + 2]; | ||||
|  | ||||
|  | ||||
|  | ||||
|     d_carr_sign = new gr_complex[d_vector_length*2]; | ||||
|  | ||||
|     /* If an array is partitioned for more than one thread to operate on, | ||||
| @@ -155,7 +147,6 @@ Gps_L1_Ca_Tcp_Connector_Tracking_cc::Gps_L1_Ca_Tcp_Connector_Tracking_cc( | ||||
|     if (posix_memalign((void**)&d_Prompt, 16, sizeof(gr_complex)) == 0){}; | ||||
|     if (posix_memalign((void**)&d_Late, 16, sizeof(gr_complex)) == 0){}; | ||||
|  | ||||
|  | ||||
|     //--- Perform initializations ------------------------------ | ||||
|     // define initial code frequency basis of NCO | ||||
|     d_code_freq_hz = GPS_L1_CA_CODE_RATE_HZ; | ||||
| @@ -355,14 +346,11 @@ Gps_L1_Ca_Tcp_Connector_Tracking_cc::~Gps_L1_Ca_Tcp_Connector_Tracking_cc() | ||||
| } | ||||
|  | ||||
|  | ||||
| /* Tracking signal processing | ||||
|  * Notice that this is a class derived from gr_sync_decimator, so each of the ninput_items has vector_length samples | ||||
|  */ | ||||
|  | ||||
|  | ||||
| int Gps_L1_Ca_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|         gr_vector_const_void_star &input_items, gr_vector_void_star &output_items) | ||||
| { | ||||
|  | ||||
|     // process vars | ||||
|     float carr_error; | ||||
|     float carr_nco; | ||||
| @@ -385,13 +373,11 @@ int Gps_L1_Ca_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_vec | ||||
|                     int acq_to_trk_delay_samples; | ||||
|                     acq_to_trk_delay_samples = d_sample_counter - d_acq_sample_stamp; | ||||
|                     acq_trk_shif_correction_samples = d_next_prn_length_samples - fmod((float)acq_to_trk_delay_samples, (float)d_next_prn_length_samples); | ||||
|                     //std::cout<<"acq_trk_shif_correction="<<acq_trk_shif_correction_samples<<"\r\n"; | ||||
|                     samples_offset = round(d_acq_code_phase_samples + acq_trk_shif_correction_samples); | ||||
|                     // /todo: Check if the sample counter sent to the next block as a time reference should be incremented AFTER sended or BEFORE | ||||
|                     d_sample_counter_seconds = d_sample_counter_seconds + (((double)samples_offset) / (double)d_fs_in); | ||||
|                     d_sample_counter = d_sample_counter + samples_offset; //count for the processed samples | ||||
|                     d_pull_in = false; | ||||
|                     //std::cout<<" samples_offset="<<samples_offset<<"\r\n"; | ||||
|                     consume_each(samples_offset); //shift input to perform alignement with local replica | ||||
|                     return 1; | ||||
|                 } | ||||
| @@ -450,7 +436,15 @@ int Gps_L1_Ca_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_vec | ||||
|             d_control_id++; | ||||
|  | ||||
|             //! Send and receive a TCP packet | ||||
|              boost::array<float, NUM_TX_VARIABLES_GPS_L1_CA> tx_variables_array = {{d_control_id,(*d_Early).real(),(*d_Early).imag(),(*d_Late).real(),(*d_Late).imag(),(*d_Prompt).real(),(*d_Prompt).imag(),d_acq_carrier_doppler_hz,1}}; | ||||
|             boost::array<float, NUM_TX_VARIABLES_GPS_L1_CA> tx_variables_array = {{d_control_id, | ||||
|                                                                                    (*d_Early).real(), | ||||
|                                                                                    (*d_Early).imag(), | ||||
|                                                                                    (*d_Late).real(), | ||||
|                                                                                    (*d_Late).imag(), | ||||
|                                                                                    (*d_Prompt).real(), | ||||
|                                                                                    (*d_Prompt).imag(), | ||||
|                                                                                    d_acq_carrier_doppler_hz, | ||||
|                                                                                    1}}; | ||||
|             d_tcp_com.send_receive_tcp_packet_gps_l1_ca(tx_variables_array, &tcp_data); | ||||
|  | ||||
|             //! Recover the tracking data | ||||
| @@ -632,7 +626,7 @@ int Gps_L1_Ca_Tcp_Connector_Tracking_cc::general_work (int noutput_items, gr_vec | ||||
|             } | ||||
|         } | ||||
|  | ||||
|     consume_each(d_current_prn_length_samples); // this is necesary in gr_block derivates | ||||
|     consume_each(d_current_prn_length_samples); // this is necessary in gr::block derivates | ||||
|     d_sample_counter_seconds = d_sample_counter_seconds + ( ((double)d_current_prn_length_samples) / (double)d_fs_in ); | ||||
|     d_sample_counter += d_current_prn_length_samples; //count for the processed samples | ||||
|     return 1; //output tracking result ALWAYS even in the case of d_enable_tracking==false | ||||
| @@ -682,7 +676,6 @@ void Gps_L1_Ca_Tcp_Connector_Tracking_cc::set_channel_queue(concurrent_queue<int | ||||
| void Gps_L1_Ca_Tcp_Connector_Tracking_cc::set_gnss_synchro(Gnss_Synchro* p_gnss_synchro) | ||||
| { | ||||
|     d_acquisition_gnss_synchro = p_gnss_synchro; | ||||
|  | ||||
|     //	Gnss_Satellite(satellite.get_system(), satellite.get_PRN()); | ||||
|     //DLOG(INFO) << "Tracking code phase set to " << d_acq_code_phase_samples; | ||||
|     //DLOG(INFO) << "Tracking carrier doppler set to " << d_acq_carrier_doppler_hz; | ||||
|   | ||||
| @@ -42,7 +42,6 @@ | ||||
| #include <boost/thread/thread.hpp> | ||||
| #include <gnuradio/block.h> | ||||
| #include <gnuradio/msg_queue.h> | ||||
| //#include <gnuradio/gr_sync_decimator.h> | ||||
| #include "concurrent_queue.h" | ||||
| #include "gps_sdr_signal_processing.h" | ||||
| #include "gnss_synchro.h" | ||||
| @@ -54,8 +53,8 @@ | ||||
|  | ||||
|  | ||||
| class Gps_L1_Ca_Tcp_Connector_Tracking_cc; | ||||
| typedef boost::shared_ptr<Gps_L1_Ca_Tcp_Connector_Tracking_cc> | ||||
|         gps_l1_ca_tcp_connector_tracking_cc_sptr; | ||||
|  | ||||
| typedef boost::shared_ptr<Gps_L1_Ca_Tcp_Connector_Tracking_cc> gps_l1_ca_tcp_connector_tracking_cc_sptr; | ||||
|  | ||||
| gps_l1_ca_tcp_connector_tracking_cc_sptr | ||||
| gps_l1_ca_tcp_connector_make_tracking_cc(long if_freq, | ||||
| @@ -69,7 +68,6 @@ gps_l1_ca_tcp_connector_make_tracking_cc(long if_freq, | ||||
|                                    float early_late_space_chips, | ||||
|                                    size_t port_ch0); | ||||
|  | ||||
| //class gps_l1_ca_tcp_connector_tracking_cc: public gr_sync_decimator | ||||
|  | ||||
| /*! | ||||
|  * \brief This class implements a DLL + PLL tracking loop block | ||||
| @@ -77,7 +75,6 @@ gps_l1_ca_tcp_connector_make_tracking_cc(long if_freq, | ||||
| class Gps_L1_Ca_Tcp_Connector_Tracking_cc: public gr::block | ||||
| { | ||||
| public: | ||||
|  | ||||
|     ~Gps_L1_Ca_Tcp_Connector_Tracking_cc(); | ||||
|  | ||||
|     void set_channel(unsigned int channel); | ||||
| @@ -90,15 +87,11 @@ public: | ||||
|      * | ||||
|      * The user must override work to define the signal processing code | ||||
|      */ | ||||
|  | ||||
|     int general_work (int noutput_items, gr_vector_int &ninput_items, | ||||
|             gr_vector_const_void_star &input_items, gr_vector_void_star &output_items); | ||||
|  | ||||
|     void forecast (int noutput_items, gr_vector_int &ninput_items_required); | ||||
|  | ||||
|  | ||||
| private: | ||||
|  | ||||
|     friend gps_l1_ca_tcp_connector_tracking_cc_sptr | ||||
|     gps_l1_ca_tcp_connector_make_tracking_cc(long if_freq, | ||||
|             long fs_in, unsigned | ||||
|   | ||||
| @@ -73,14 +73,12 @@ const double GPS_STARTOFFSET_ms = 68.802; //[ms] Initial sign. travel time (this | ||||
| const int GPS_CA_PREAMBLE_LENGTH_BITS = 8; | ||||
| const int GPS_CA_TELEMETRY_RATE_BITS_SECOND = 50;   //!< NAV message bit rate [bits/s] | ||||
| const int GPS_CA_TELEMETRY_RATE_SYMBOLS_SECOND = GPS_CA_TELEMETRY_RATE_BITS_SECOND*20;   //!< NAV message bit rate [symbols/s] | ||||
| const int GPS_WORD_LENGTH = 4;                      // CRC + GPS WORD (-2 -1 0 ... 29) Bits = 4 bytes | ||||
| const int GPS_SUBFRAME_LENGTH = 40;                 // GPS_WORD_LENGTH x 10 = 40 bytes | ||||
| const int GPS_WORD_LENGTH = 4;                      //!< CRC + GPS WORD (-2 -1 0 ... 29) Bits = 4 bytes | ||||
| const int GPS_SUBFRAME_LENGTH = 40;                 //!< GPS_WORD_LENGTH x 10 = 40 bytes | ||||
| const int GPS_SUBFRAME_BITS = 300;                  //!< Number of bits per subframe in the NAV message [bits] | ||||
| const int GPS_SUBFRAME_SECONDS = 6;                 //!< Subframe duration [seconds] | ||||
| const int GPS_WORD_BITS = 30;                       //!< Number of bits per word in the NAV message [bits] | ||||
|  | ||||
|  | ||||
|  | ||||
| // GPS NAVIGATION MESSAGE STRUCTURE | ||||
| // NAVIGATION MESSAGE FIELDS POSITIONS (from IS-GPS-200E Appendix II) | ||||
|  | ||||
| @@ -92,7 +90,6 @@ const std::vector<std::pair<int,int> > ALERT_FLAG({{48,1}}); | ||||
| const std::vector<std::pair<int,int> > ANTI_SPOOFING_FLAG({{49,1}}); | ||||
| const std::vector<std::pair<int,int> > SUBFRAME_ID({{50,3}}); | ||||
|  | ||||
|  | ||||
| // SUBFRAME 1 | ||||
| const std::vector<std::pair<int,int>> GPS_WEEK({{61,10}}); | ||||
| const std::vector<std::pair<int,int>> CA_OR_P_ON_L2({{71,2}}); //* | ||||
| @@ -101,11 +98,9 @@ const std::vector<std::pair<int,int>> SV_HEALTH ({{77,6}}); | ||||
| const std::vector<std::pair<int,int>> L2_P_DATA_FLAG ({{91,1}}); | ||||
| const std::vector<std::pair<int,int>> T_GD({{197,8}}); | ||||
| const double T_GD_LSB = TWO_N31; | ||||
|  | ||||
| const std::vector<std::pair<int,int>> IODC({{83,2},{211,8}}); | ||||
| const std::vector<std::pair<int,int>> T_OC({{219,16}}); | ||||
| const double T_OC_LSB = TWO_P4; | ||||
|  | ||||
| const std::vector<std::pair<int,int>> A_F2({{241,8}}); | ||||
| const double A_F2_LSB = TWO_N55; | ||||
| const std::vector<std::pair<int,int>> A_F1({{249,16}}); | ||||
| @@ -114,7 +109,6 @@ const std::vector<std::pair<int,int>> A_F0({{271,22}}); | ||||
| const double A_F0_LSB = TWO_N31; | ||||
|  | ||||
| // SUBFRAME 2 | ||||
|  | ||||
| const std::vector<std::pair<int,int>> IODE_SF2({{61,8}}); | ||||
| const std::vector<std::pair<int,int>> C_RS({{69,16}}); | ||||
| const double C_RS_LSB = TWO_N5; | ||||
| @@ -137,7 +131,6 @@ const std::vector<std::pair<int,int>> AODO({{272,5}}); | ||||
| const int AODO_LSB = 900; | ||||
|  | ||||
| // SUBFRAME 3 | ||||
|  | ||||
| const std::vector<std::pair<int,int>> C_IC({{61,16}}); | ||||
| const double C_IC_LSB = TWO_N29; | ||||
| const std::vector<std::pair<int,int>> OMEGA_0({{77,8},{91,24}}); | ||||
| @@ -158,14 +151,11 @@ const double I_DOT_LSB = PI_TWO_N43; | ||||
|  | ||||
|  | ||||
| // SUBFRAME 4-5 | ||||
|  | ||||
| const std::vector<std::pair<int,int>> SV_DATA_ID({{61,2}}); | ||||
| const std::vector<std::pair<int,int>> SV_PAGE({{63,6}}); | ||||
|  | ||||
| // SUBFRAME 4 | ||||
|  | ||||
| //! \todo read all pages of subframe 4 | ||||
|  | ||||
| // Page 18 - Ionospheric and UTC data | ||||
| const std::vector<std::pair<int,int>> ALPHA_0({{69,8}}); | ||||
| const double ALPHA_0_LSB = TWO_N30; | ||||
| @@ -211,13 +201,9 @@ const std::vector<std::pair<int,int>> HEALTH_SV31({{277,6}}); | ||||
| const std::vector<std::pair<int,int>> HEALTH_SV32({{283,6}}); | ||||
|  | ||||
|  | ||||
|  | ||||
|  | ||||
|  | ||||
| // SUBFRAME 5 | ||||
| //! \todo read all pages of subframe 5 | ||||
|  | ||||
|  | ||||
| // page 25 - Health (PRN 1 - 24) | ||||
| const std::vector<std::pair<int,int>> T_OA({{69,8}}); | ||||
| const double T_OA_LSB = TWO_P12; | ||||
| @@ -247,74 +233,4 @@ const std::vector<std::pair<int,int>> HEALTH_SV22({{247,6}}); | ||||
| const std::vector<std::pair<int,int>> HEALTH_SV23({{253,6}}); | ||||
| const std::vector<std::pair<int,int>> HEALTH_SV24({{259,6}}); | ||||
|  | ||||
| /* | ||||
|  | ||||
| inline void ca_code_generator_complex(std::complex<float>* _dest, signed int _prn, unsigned int _chip_shift) | ||||
| { | ||||
|  | ||||
|         unsigned int G1[1023]; | ||||
|         unsigned int G2[1023]; | ||||
|         unsigned int G1_register[10], G2_register[10]; | ||||
|         unsigned int feedback1, feedback2; | ||||
|         unsigned int lcv, lcv2; | ||||
|         unsigned int delay; | ||||
|         signed int prn = _prn-1; //Move the PRN code to fit an array indices | ||||
|  | ||||
|         // G2 Delays as defined in IS-GPS-200E | ||||
|         signed int delays[32] = {5, 6, 7, 8, 17, 18, 139, 140, 141, 251, | ||||
|                 252, 254, 255, 256, 257, 258, 469, 470, 471, 472, | ||||
|                 473, 474, 509, 512, 513, 514, 515, 516, 859, 860, | ||||
|                 861, 862}; | ||||
|         // PRN sequences 33 through 37 are reserved for other uses (e.g. ground transmitters) | ||||
|  | ||||
|         // A simple error check | ||||
|         if((prn < 0) || (prn > 32)) | ||||
|                 return; | ||||
|  | ||||
|         for(lcv = 0; lcv < 10; lcv++) | ||||
|         { | ||||
|                 G1_register[lcv] = 1; | ||||
|                 G2_register[lcv] = 1; | ||||
|         } | ||||
|  | ||||
|         // Generate G1 & G2 Register | ||||
|         for(lcv = 0; lcv < 1023; lcv++) | ||||
|         { | ||||
|                 G1[lcv] = G1_register[0]; | ||||
|                 G2[lcv] = G2_register[0]; | ||||
|  | ||||
|                 feedback1 = G1_register[7]^G1_register[0]; | ||||
|                 feedback2 = (G2_register[8] + G2_register[7] + G2_register[4] + G2_register[2] + G2_register[1] + G2_register[0]) & 0x1; | ||||
|  | ||||
|                 for(lcv2 = 0; lcv2 < 9; lcv2++) | ||||
|                 { | ||||
|                         G1_register[lcv2] = G1_register[lcv2 + 1]; | ||||
|                         G2_register[lcv2] = G2_register[lcv2 + 1]; | ||||
|                 } | ||||
|  | ||||
|                 G1_register[9] = feedback1; | ||||
|                 G2_register[9] = feedback2; | ||||
|         } | ||||
|  | ||||
|         // Set the delay | ||||
|         delay = 1023 - delays[prn]; | ||||
|         delay += _chip_shift; | ||||
|         delay %= 1023; | ||||
|         // Generate PRN from G1 and G2 Registers | ||||
|         for(lcv = 0; lcv < 1023; lcv++) | ||||
|         { | ||||
|                 _dest[lcv] = std::complex<float>(G1[(lcv +  _chip_shift)%1023]^G2[delay], 0); | ||||
|                 if(_dest[lcv].real() == 0.0) //javi | ||||
|                 { | ||||
|                         _dest[lcv].real(-1.0); | ||||
|                 } | ||||
|                 delay++; | ||||
|                 delay %= 1023; | ||||
|                 //std::cout<<_dest[lcv].real(); //OK | ||||
|         } | ||||
| } | ||||
|  | ||||
| */ | ||||
|  | ||||
|  | ||||
| #endif /* GNSS_SDR_GPS_L1_CA_H_ */ | ||||
|   | ||||
		Reference in New Issue
	
	Block a user
	 Carles Fernandez
					Carles Fernandez