aboutsummaryrefslogtreecommitdiffstats
diff options
context:
space:
mode:
-rwxr-xr-xapps/grgsm_livemon11
-rw-r--r--apps/grgsm_livemon.grc16
-rw-r--r--grc/gsm_block_tree.xml1
-rw-r--r--grc/misc_utils/CMakeLists.txt1
-rwxr-xr-xgrc/misc_utils/gsm_extract_cmc.xml20
-rw-r--r--include/grgsm/misc_utils/CMakeLists.txt1
-rwxr-xr-xinclude/grgsm/misc_utils/extract_cmc.h59
-rw-r--r--lib/CMakeLists.txt1
-rwxr-xr-xlib/misc_utils/extract_cmc_impl.cc90
-rwxr-xr-xlib/misc_utils/extract_cmc_impl.h45
-rw-r--r--lib/misc_utils/extract_system_info_impl.cc11
-rw-r--r--lib/receiver/receiver_impl.cc85
-rw-r--r--lib/receiver/receiver_impl.h6
-rw-r--r--swig/grgsm_swig.i3
14 files changed, 254 insertions, 96 deletions
diff --git a/apps/grgsm_livemon b/apps/grgsm_livemon
index d4376e4..765ebae 100755
--- a/apps/grgsm_livemon
+++ b/apps/grgsm_livemon
@@ -5,7 +5,7 @@
# Title: Gr-gsm Livemon
# Author: Piotr Krysik
# Description: Interactive monitor of a single C0 channel with analysis performed by Wireshark (command to run wireshark: sudo wireshark -k -f udp -Y gsmtap -i lo)
-# Generated: Mon Jul 18 18:08:34 2016
+# Generated: Mon Jan 23 21:28:25 2017
##################################################
if __name__ == '__main__':
@@ -82,13 +82,13 @@ class grgsm_livemon(gr.top_block, Qt.QWidget):
##################################################
# Blocks
##################################################
- self._ppm_slider_range = Range(-150, 150, 1, ppm, 100)
+ self._ppm_slider_range = Range(-150, 150, 0.1, ppm, 100)
self._ppm_slider_win = RangeWidget(self._ppm_slider_range, self.set_ppm_slider, "PPM Offset", "counter", float)
self.top_layout.addWidget(self._ppm_slider_win)
self._g_slider_range = Range(0, 50, 0.5, gain, 100)
self._g_slider_win = RangeWidget(self._g_slider_range, self.set_g_slider, "Gain", "counter", float)
self.top_layout.addWidget(self._g_slider_win)
- self._fc_slider_range = Range(925e6, 1990e6, 2e5, fc, 100)
+ self._fc_slider_range = Range(800e6, 1990e6, 2e5, fc, 100)
self._fc_slider_win = RangeWidget(self._fc_slider_range, self.set_fc_slider, "Frequency", "counter_slider", float)
self.top_layout.addWidget(self._fc_slider_win)
self.rtlsdr_source_0 = osmosdr.source( args="numchan=" + str(1) + " " + args )
@@ -152,7 +152,7 @@ class grgsm_livemon(gr.top_block, Qt.QWidget):
self.gsm_message_printer_1 = grgsm.message_printer(pmt.intern(""), False,
False, False)
self.gsm_input_0 = grgsm.gsm_input(
- ppm=0,
+ ppm=ppm-int(ppm),
osr=4,
fc=fc,
samp_rate_in=samp_rate,
@@ -220,6 +220,7 @@ class grgsm_livemon(gr.top_block, Qt.QWidget):
def set_ppm(self, ppm):
self.ppm = ppm
self.set_ppm_slider(self.ppm)
+ self.gsm_input_0.set_ppm(self.ppm-int(self.ppm))
def get_samp_rate(self):
return self.samp_rate
@@ -281,7 +282,7 @@ def argument_parser():
"-g", "--gain", dest="gain", type="eng_float", default=eng_notation.num_to_str(30),
help="Set gain [default=%default]")
parser.add_option(
- "-p", "--ppm", dest="ppm", type="intx", default=0,
+ "-p", "--ppm", dest="ppm", type="eng_float", default=eng_notation.num_to_str(0),
help="Set ppm [default=%default]")
parser.add_option(
"-s", "--samp-rate", dest="samp_rate", type="eng_float", default=eng_notation.num_to_str(2000000.052982),
diff --git a/apps/grgsm_livemon.grc b/apps/grgsm_livemon.grc
index 6394924..77640c9 100644
--- a/apps/grgsm_livemon.grc
+++ b/apps/grgsm_livemon.grc
@@ -125,7 +125,7 @@
</param>
<param>
<key>start</key>
- <value>925e6</value>
+ <value>800e6</value>
</param>
<param>
<key>step</key>
@@ -255,7 +255,7 @@
</param>
<param>
<key>step</key>
- <value>1</value>
+ <value>0.1</value>
</param>
<param>
<key>stop</key>
@@ -580,7 +580,7 @@
</param>
<param>
<key>_coordinate</key>
- <value>(896, 283)</value>
+ <value>(896, 284)</value>
</param>
<param>
<key>_rotation</key>
@@ -756,7 +756,7 @@
</param>
<param>
<key>_coordinate</key>
- <value>(1112, 331)</value>
+ <value>(1104, 333)</value>
</param>
<param>
<key>_rotation</key>
@@ -827,7 +827,7 @@
</param>
<param>
<key>ppm</key>
- <value>0</value>
+ <value>ppm-int(ppm)</value>
</param>
<param>
<key>samp_rate_in</key>
@@ -854,7 +854,7 @@
</param>
<param>
<key>_coordinate</key>
- <value>(1496, 291)</value>
+ <value>(1512, 270)</value>
</param>
<param>
<key>_rotation</key>
@@ -956,7 +956,7 @@
</param>
<param>
<key>_coordinate</key>
- <value>(912, 339)</value>
+ <value>(896, 340)</value>
</param>
<param>
<key>_rotation</key>
@@ -1089,7 +1089,7 @@
</param>
<param>
<key>type</key>
- <value>intx</value>
+ <value>eng_float</value>
</param>
<param>
<key>value</key>
diff --git a/grc/gsm_block_tree.xml b/grc/gsm_block_tree.xml
index bb705c9..c2e1ee7 100644
--- a/grc/gsm_block_tree.xml
+++ b/grc/gsm_block_tree.xml
@@ -59,6 +59,7 @@
<block>gsm_message_file_source</block>
<block>gsm_extract_system_info</block>
<block>gsm_extract_immediate_assignment</block>
+ <block>gsm_extract_cmc</block>
<block>gsm_controlled_rotator_cc</block>
<block>gsm_controlled_fractional_resampler_cc</block>
<block>gsm_message_printer</block>
diff --git a/grc/misc_utils/CMakeLists.txt b/grc/misc_utils/CMakeLists.txt
index 43c3960..adb90d3 100644
--- a/grc/misc_utils/CMakeLists.txt
+++ b/grc/misc_utils/CMakeLists.txt
@@ -21,6 +21,7 @@ install(FILES
gsm_extract_system_info.xml
gsm_extract_immediate_assignment.xml
gsm_collect_system_info.xml
+ gsm_extract_cmc.xml
gsm_controlled_rotator_cc.xml
gsm_message_printer.xml
gsm_bursts_printer.xml
diff --git a/grc/misc_utils/gsm_extract_cmc.xml b/grc/misc_utils/gsm_extract_cmc.xml
new file mode 100755
index 0000000..66a6408
--- /dev/null
+++ b/grc/misc_utils/gsm_extract_cmc.xml
@@ -0,0 +1,20 @@
+<?xml version="1.0"?>
+<block>
+ <name>Extract Cipher Mode Command</name>
+ <key>gsm_extract_cmc</key>
+ <import>import grgsm</import>
+ <make>grgsm.extract_cmc()</make>
+ <sink>
+ <name>msgs</name>
+ <type>message</type>
+ </sink>
+ <doc>
+Extracts the framenumber and the assigned encryption algorithm from Cipher Mode Commands.
+
+Input: decoded control channel messages
+
+The information can be retrieved using following functions:
+get_frame_numbers(), get_a5_versions()
+
+</doc>
+</block>
diff --git a/include/grgsm/misc_utils/CMakeLists.txt b/include/grgsm/misc_utils/CMakeLists.txt
index d603a01..878fcfd 100644
--- a/include/grgsm/misc_utils/CMakeLists.txt
+++ b/include/grgsm/misc_utils/CMakeLists.txt
@@ -29,6 +29,7 @@ install(FILES
message_file_source.h
extract_system_info.h
extract_immediate_assignment.h
+ extract_cmc.h
controlled_rotator_cc.h
message_printer.h
tmsi_dumper.h
diff --git a/include/grgsm/misc_utils/extract_cmc.h b/include/grgsm/misc_utils/extract_cmc.h
new file mode 100755
index 0000000..8af12be
--- /dev/null
+++ b/include/grgsm/misc_utils/extract_cmc.h
@@ -0,0 +1,59 @@
+/* -*- c++ -*- */
+/*
+ * @file
+ * @author Roman Khassraf <rkhassraf@gmail.com>
+ * @section LICENSE
+ *
+ * Gr-gsm is free software; you can redistribute it and/or modify
+ * it under the terms of the GNU General Public License as published by
+ * the Free Software Foundation; either version 3, or (at your option)
+ * any later version.
+ *
+ * Gr-gsm is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
+ * GNU General Public License for more details.
+ *
+ * You should have received a copy of the GNU General Public License
+ * along with gr-gsm; see the file COPYING. If not, write to
+ * the Free Software Foundation, Inc., 51 Franklin Street,
+ * Boston, MA 02110-1301, USA.
+ */
+
+
+#ifndef INCLUDED_GSM_EXTRACT_CMC_H
+#define INCLUDED_GSM_EXTRACT_CMC_H
+
+#include <grgsm/api.h>
+#include <gnuradio/block.h>
+#include <vector>
+
+namespace gr {
+ namespace gsm {
+
+ /*!
+ * \brief <+description of block+>
+ * \ingroup gsm
+ *
+ */
+ class GRGSM_API extract_cmc : virtual public gr::block
+ {
+ public:
+ typedef boost::shared_ptr<extract_cmc> sptr;
+
+ /*!
+ * \brief Return a shared_ptr to a new instance of gsm::extract_cmc.
+ *
+ * To avoid accidental use of raw pointers, gsm::extract_cmc's
+ * constructor is in a private implementation
+ * class. gsm::extract_cmc::make is the public interface for
+ * creating new instances.
+ */
+ static sptr make();
+ virtual std::vector<int> get_framenumbers() = 0;
+ virtual std::vector<int> get_a5_versions() = 0;
+ };
+
+ } // namespace gsm
+} // namespace gr
+#endif /* INCLUDED_GSM_EXTRACT_CMC_H */
diff --git a/lib/CMakeLists.txt b/lib/CMakeLists.txt
index 6e00442..680c41f 100644
--- a/lib/CMakeLists.txt
+++ b/lib/CMakeLists.txt
@@ -63,6 +63,7 @@ list(APPEND grgsm_sources
misc_utils/bursts_printer_impl.cc
misc_utils/extract_system_info_impl.cc
misc_utils/extract_immediate_assignment_impl.cc
+ misc_utils/extract_cmc_impl.cc
qa_utils/burst_sink_impl.cc
qa_utils/burst_source_impl.cc
qa_utils/message_source_impl.cc
diff --git a/lib/misc_utils/extract_cmc_impl.cc b/lib/misc_utils/extract_cmc_impl.cc
new file mode 100755
index 0000000..b367def
--- /dev/null
+++ b/lib/misc_utils/extract_cmc_impl.cc
@@ -0,0 +1,90 @@
+/* -*- c++ -*- */
+/*
+ * @file
+ * @author Roman Khassraf <rkhassraf@gmail.com>
+ * @section LICENSE
+ *
+ * Gr-gsm is free software; you can redistribute it and/or modify
+ * it under the terms of the GNU General Public License as published by
+ * the Free Software Foundation; either version 3, or (at your option)
+ * any later version.
+ *
+ * Gr-gsm is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
+ * GNU General Public License for more details.
+ *
+ * You should have received a copy of the GNU General Public License
+ * along with gr-gsm; see the file COPYING. If not, write to
+ * the Free Software Foundation, Inc., 51 Franklin Street,
+ * Boston, MA 02110-1301, USA.
+ */
+
+#ifdef HAVE_CONFIG_H
+#include "config.h"
+#endif
+
+#include <gnuradio/io_signature.h>
+#include <grgsm/gsmtap.h>
+#include <unistd.h>
+#include <grgsm/endian.h>
+
+#include "extract_cmc_impl.h"
+
+namespace gr {
+ namespace gsm {
+ void extract_cmc_impl::process_messages(pmt::pmt_t msg)
+ {
+ pmt::pmt_t message_plus_header_blob = pmt::cdr(msg);
+ uint8_t * message_plus_header = (uint8_t *)pmt::blob_data(message_plus_header_blob);
+ gsmtap_hdr * header = (gsmtap_hdr *)message_plus_header;
+ uint8_t * msg_elements = (uint8_t *)(message_plus_header+sizeof(gsmtap_hdr));
+
+ if((msg_elements[3] & 0xF) == 0x6 && msg_elements[4] == 0x35)
+ {
+
+ int frame_nr = be32toh(header->frame_number);
+ int a5_version = ((msg_elements[5] & 0xE) >> 1) + 1;
+
+ d_framenumbers.push_back(frame_nr);
+ d_a5_versions.push_back(a5_version);
+ }
+ }
+
+ std::vector<int> extract_cmc_impl::get_framenumbers()
+ {
+ return d_framenumbers;
+ }
+
+ std::vector<int> extract_cmc_impl::get_a5_versions()
+ {
+ return d_a5_versions;
+ }
+
+ extract_cmc::sptr
+ extract_cmc::make()
+ {
+ return gnuradio::get_initial_sptr
+ (new extract_cmc_impl());
+ }
+
+ /*
+ * The private constructor
+ */
+ extract_cmc_impl::extract_cmc_impl()
+ : gr::block("extract_cmc",
+ gr::io_signature::make(0, 0, 0),
+ gr::io_signature::make(0, 0, 0))
+ {
+ message_port_register_in(pmt::mp("msgs"));
+ set_msg_handler(pmt::mp("msgs"), boost::bind(&extract_cmc_impl::process_messages, this, _1));
+ }
+
+ /*
+ * Our virtual destructor.
+ */
+ extract_cmc_impl::~extract_cmc_impl()
+ {
+ }
+ } /* namespace gsm */
+} /* namespace gr */
diff --git a/lib/misc_utils/extract_cmc_impl.h b/lib/misc_utils/extract_cmc_impl.h
new file mode 100755
index 0000000..fe97f22
--- /dev/null
+++ b/lib/misc_utils/extract_cmc_impl.h
@@ -0,0 +1,45 @@
+/* -*- c++ -*- */
+/*
+ * @file
+ * @author Roman Khassraf <rkhassraf@gmail.com>
+ * @section LICENSE
+ *
+ * Gr-gsm is free software; you can redistribute it and/or modify
+ * it under the terms of the GNU General Public License as published by
+ * the Free Software Foundation; either version 3, or (at your option)
+ * any later version.
+ *
+ * Gr-gsm is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
+ * GNU General Public License for more details.
+ *
+ * You should have received a copy of the GNU General Public License
+ * along with gr-gsm; see the file COPYING. If not, write to
+ * the Free Software Foundation, Inc., 51 Franklin Street,
+ * Boston, MA 02110-1301, USA.
+ */
+
+#ifndef INCLUDED_GSM_EXTRACT_CMC_IMPL_H
+#define INCLUDED_GSM_EXTRACT_CMC_IMPL_H
+
+#include <grgsm/misc_utils/extract_cmc.h>
+#include <vector>
+
+namespace gr {
+ namespace gsm {
+ class extract_cmc_impl : public extract_cmc
+ {
+ private:
+ void process_messages(pmt::pmt_t msg);
+ std::vector<int> d_framenumbers;
+ std::vector<int> d_a5_versions;
+ public:
+ virtual std::vector<int> get_framenumbers();
+ virtual std::vector<int> get_a5_versions();
+ extract_cmc_impl();
+ ~extract_cmc_impl();
+ };
+ } // namespace gsm
+} // namespace gr
+#endif /* INCLUDED_GSM_EXTRACT_CMC_IMPL_H */
diff --git a/lib/misc_utils/extract_system_info_impl.cc b/lib/misc_utils/extract_system_info_impl.cc
index bb7fada..6f745a0 100644
--- a/lib/misc_utils/extract_system_info_impl.cc
+++ b/lib/misc_utils/extract_system_info_impl.cc
@@ -76,6 +76,12 @@ namespace gr {
info.lac = (msg_elements[8]<<8)+msg_elements[9]; //take lac
info.mcc = ((msg_elements[5] & 0xF) * 100) + (((msg_elements[5] & 0xF0) >> 4) * 10) + ((msg_elements[6] & 0xF)); // take mcc
info.mnc = (msg_elements[7] & 0xF) * 10 + (msg_elements[7]>>4); //take mnc
+ if (((msg_elements[6] & 0xF0) >> 4) < 10) // we have a 3 digit mnc, see figure 10.5.3 of 3GPP TS 24.008
+ {
+ info.mnc *= 10;
+ info.mnc += (msg_elements[6] & 0xF0) >> 4;
+ }
+
info.ccch_conf = (msg_elements[10] & 0x7); // ccch_conf
boost::mutex::scoped_lock lock(extract_mutex);
@@ -92,6 +98,11 @@ namespace gr {
info.lac = (msg_elements[6]<<8)+msg_elements[7]; //take lac
info.mcc = ((msg_elements[3] & 0xF) * 100) + (((msg_elements[3] & 0xF0) >> 4) * 10) + ((msg_elements[4] & 0xF)); // take mcc
info.mnc = (msg_elements[5] & 0xF) * 10 + (msg_elements[5]>>4); //take mnc
+ if (((msg_elements[4] & 0xF0) >> 4) < 10) // we have a 3 digit mnc, see figure 10.5.3 of 3GPP TS 24.008
+ {
+ info.mnc *= 10;
+ info.mnc += (msg_elements[4] & 0xF0) >> 4;
+ }
boost::mutex::scoped_lock lock(extract_mutex);
if(d_c0_channels.find(info.id) != d_c0_channels.end()){
diff --git a/lib/receiver/receiver_impl.cc b/lib/receiver/receiver_impl.cc
index f55d613..e69183f 100644
--- a/lib/receiver/receiver_impl.cc
+++ b/lib/receiver/receiver_impl.cc
@@ -26,7 +26,6 @@
#include <gnuradio/io_signature.h>
#include <gnuradio/math.h>
-#include <volk/volk.h>
#include <math.h>
#include <boost/circular_buffer.hpp>
#include <algorithm>
@@ -35,7 +34,6 @@
#include <viterbi_detector.h>
#include <string.h>
#include <iostream>
-#include <time.h> //!!!
//#include <iomanip>
#include <boost/scoped_ptr.hpp>
@@ -82,10 +80,6 @@ receiver_impl::receiver_impl(int osr, const std::vector<int> &cell_allocation, c
d_last_time(0.0)
{
int i;
-
- unsigned int alignment = volk_get_alignment();
- d_freq_estim_vector = (lv_32fc_t*)volk_malloc(sizeof(lv_32fc_t)*160, alignment);
- d_freq_estim_result = (lv_32fc_t*)volk_malloc(sizeof(lv_32fc_t)*1, alignment);
//don't send samples to the receiver until there are at least samples for one
set_output_multiple(floor((TS_BITS + 2 * GUARD_PERIOD) * d_OSR)); // burst and two gurad periods (one gurard period is an arbitrary overlap)
gmsk_mapper(SYNC_BITS, N_SYNC_BITS, d_sch_training_seq, gr_complex(0.0, -1.0));
@@ -106,8 +100,6 @@ receiver_impl::receiver_impl(int osr, const std::vector<int> &cell_allocation, c
*/
receiver_impl::~receiver_impl()
{
- volk_free(d_freq_estim_vector);
- volk_free(d_freq_estim_result);
}
int
@@ -294,7 +286,7 @@ receiver_impl::work(int noutput_items,
dummy_burst_start = get_norm_chan_imp_resp(input, &channel_imp_resp[0], &dummy_corr_max, TS_DUMMY);
normal_burst_start = get_norm_chan_imp_resp(input, &channel_imp_resp[0], &normal_corr_max, d_bcc);
-
+
if (normal_corr_max > dummy_corr_max)
{
d_c0_burst_start = normal_burst_start;
@@ -540,83 +532,22 @@ bool receiver_impl::find_fcch_burst(const gr_complex *input, const int nitems, d
return result;
}
-double receiver_impl::estim_freq_norm(const gr_complex * input, unsigned first_sample, unsigned last_sample) //another frequency estimator
-{
-
- unsigned ii;
-
- gr_complex sum = 0;
-
- for (ii = first_sample; ii < last_sample-d_OSR; ii=ii+d_OSR)
- {
- sum += input[ii+d_OSR] * conj(input[ii]);
- }
-
- return fast_atan2f(imag(sum), real(sum))/(2*M_PI);
-}
-
-double receiver_impl::estim_freq_norm2(const gr_complex * input, unsigned first_sample, unsigned last_sample) //another frequency estimator - faster one
+double receiver_impl::compute_freq_offset(const gr_complex * input, unsigned first_sample, unsigned last_sample)
{
-
+ double phase_sum = 0;
unsigned ii;
- int N = (last_sample-first_sample)/d_OSR;
-
- for (unsigned ii = 0; ii < N; ii++)
+ for (ii = first_sample; ii < last_sample; ii++)
{
- d_freq_estim_vector[ii] = input[first_sample+ii*d_OSR];
+ double phase_diff = compute_phase_diff(input[ii], input[ii-1]) - (M_PI / 2) / d_OSR;
+ phase_sum += phase_diff;
}
- volk_32fc_x2_conjugate_dot_prod_32fc(d_freq_estim_result, d_freq_estim_vector+1, d_freq_estim_vector, N-1);
-
- return fast_atan2f(imag(d_freq_estim_result[0]), real(d_freq_estim_result[0]))/(2*M_PI);
-}
-
-
-double receiver_impl::compute_freq_offset(const gr_complex * input, unsigned first_sample, unsigned last_sample)
-{
- float freq_norm = estim_freq_norm2(input, first_sample, last_sample);
-
-// using namespace std;
-// clock_t begin = clock();
-//
-// for(int ii=0;ii<500;ii++){
-// float dupa = estim_freq_norm2(input, first_sample, last_sample);
-// }
-// clock_t end = clock();
-// double elapsed_secs = double(end - begin) / CLOCKS_PER_SEC;
-// std::cout << "elapsed_secs " << elapsed_secs << std::endl;
-
-// begin = clock();
-//
-// for(int ii=0;ii<500;ii++){
-// float dupa = estim_freq_norm(input, first_sample, last_sample);
-// }
-// end = clock();
-// elapsed_secs = double(end - begin) / CLOCKS_PER_SEC;
-// std::cout << "elapsed_secs_old " << elapsed_secs << std::endl;
-
- float freq_offset = (freq_norm - 0.25) * 1625000.0/6.0;
-
+ double phase_offset = phase_sum / (last_sample - first_sample);
+ double freq_offset = phase_offset * 1625000.0 / (12.0 * M_PI);
return freq_offset;
}
-//double receiver_impl::compute_freq_offset(const gr_complex * input, unsigned first_sample, unsigned last_sample)
-//{
-// double phase_sum = 0;
-// unsigned ii;
-
-// for (ii = first_sample; ii < last_sample; ii++)
-// {
-// double phase_diff = compute_phase_diff(input[ii], input[ii-1]) - (M_PI / 2) / d_OSR;
-// phase_sum += phase_diff;
-// }
-
-// double phase_offset = phase_sum / (last_sample - first_sample);
-// double freq_offset = phase_offset * 1625000.0 / (12.0 * M_PI);
-// return freq_offset;
-//}
-
inline float receiver_impl::compute_phase_diff(gr_complex val1, gr_complex val2)
{
gr_complex conjprod = val1 * conj(val2);
diff --git a/lib/receiver/receiver_impl.h b/lib/receiver/receiver_impl.h
index eb406f3..6074dd5 100644
--- a/lib/receiver/receiver_impl.h
+++ b/lib/receiver/receiver_impl.h
@@ -37,9 +37,6 @@ namespace gr {
unsigned int d_c0_burst_start;
float d_c0_signal_dbm;
- lv_32fc_t* d_freq_estim_vector;// = (lv_32fc_t*)volk_malloc(sizeof(lv_32fc_t)*160, alignment);
- lv_32fc_t* d_freq_estim_result;// = (lv_32fc_t*)volk_malloc(sizeof(lv_32fc_t)*1, alignment);
-
/**@name Configuration of the receiver */
//@{
const int d_OSR; ///< oversampling ratio
@@ -111,9 +108,6 @@ namespace gr {
* @return true if frequency offset was faound
*/
double compute_freq_offset(const gr_complex * input, unsigned first_sample, unsigned last_sample);
-
- double estim_freq_norm(const gr_complex * input, unsigned first_sample, unsigned last_sample); //another frequency estimator
- double estim_freq_norm2(const gr_complex * input, unsigned first_sample, unsigned last_sample); //another frequency estimator
/** Computes angle between two complex numbers
*
* @param val1 first complex number
diff --git a/swig/grgsm_swig.i b/swig/grgsm_swig.i
index 4c981a7..68911ae 100644
--- a/swig/grgsm_swig.i
+++ b/swig/grgsm_swig.i
@@ -32,6 +32,7 @@
#include "grgsm/misc_utils/burst_file_sink.h"
#include "grgsm/misc_utils/burst_file_source.h"
#include "grgsm/misc_utils/collect_system_info.h"
+#include "grgsm/misc_utils/extract_cmc.h"
#include "grgsm/qa_utils/burst_sink.h"
#include "grgsm/qa_utils/burst_source.h"
#include "grgsm/qa_utils/message_source.h"
@@ -104,6 +105,8 @@ GR_SWIG_BLOCK_MAGIC2(gsm, message_file_source);
GR_SWIG_BLOCK_MAGIC2(gsm, msg_to_tag);
%include "grgsm/misc_utils/controlled_fractional_resampler_cc.h"
GR_SWIG_BLOCK_MAGIC2(gsm, controlled_fractional_resampler_cc);
+%include "grgsm/misc_utils/extract_cmc.h"
+GR_SWIG_BLOCK_MAGIC2(gsm, extract_cmc);
%include "grgsm/qa_utils/burst_sink.h"