GNU Radio 3.6.5 C++ API

Class List

Here are the classes, structs, unions and interfaces with brief descriptions:
AadvarkModels the mammal Aadvark
gr::filter::adaptive_fir_cccAdaptive FIR filter with gr_complex input, gr_complex output and gr_complex taps
gr::filter::adaptive_fir_ccc_impl
gr::filter::adaptive_fir_ccfAdaptive FIR filter with gr_complex input, gr_complex output and float taps
gr::filter::adaptive_fir_ccf_impl
gr::blocks::add_ccOutput = sum (input_0, input_1, ...)
gr::blocks::add_cc_impl
gr::blocks::add_const_ccOutput = input + constant
gr::blocks::add_const_cc_impl
gr::blocks::add_const_ffOutput = input + constant
gr::blocks::add_const_ff_impl
gr::blocks::add_const_iiOutput = input + constant
gr::blocks::add_const_ii_impl
gr::blocks::add_const_ssOutput = input + constant
gr::blocks::add_const_ss_impl
gr::blocks::add_const_vccOutput = input + constant vector
gr::blocks::add_const_vcc_impl
gr::blocks::add_const_vffOutput = input + constant vector
gr::blocks::add_const_vff_impl
gr::blocks::add_const_viiOutput = input + constant vector
gr::blocks::add_const_vii_impl
gr::blocks::add_const_vssOutput = input + constant vector
gr::blocks::add_const_vss_impl
gr::blocks::add_ffOutput = sum (input_0, input_1, ...)
gr::blocks::add_ff_impl
gr::blocks::add_iiOutput = sum (input_0, input_1, ...)
gr::blocks::add_ii_impl
gr::blocks::add_ssOutput = sum (input_0, input_1, ...)
gr::blocks::add_ss_impl
gr::analog::kernel::agc2_ccHigh performance Automatic Gain Control class
gr::analog::agc2_ccHigh performance Automatic Gain Control class
gr::analog::agc2_cc_impl
gr::analog::kernel::agc2_ff
gr::analog::agc2_ffHigh performance Automatic Gain Control class
gr::analog::agc2_ff_impl
gr::analog::kernel::agc_ccHigh performance Automatic Gain Control class for complex signals
gr::analog::agc_ccHigh performance Automatic Gain Control class
gr::analog::agc_cc_impl
gr::analog::kernel::agc_ffHigh performance Automatic Gain Control class for float signals
gr::analog::agc_ffHigh performance Automatic Gain Control class
gr::analog::agc_ff_impl
gr::blocks::and_bbOutput = input_0 & input_1 & , ... & input_N)bitwise boolean and across all input streams
gr::blocks::and_bb_impl
gr::blocks::and_const_bbOutput_N = input_N & valuebitwise boolean and of const to the data stream
gr::blocks::and_const_bb_impl
gr::blocks::and_const_iiOutput_N = input_N & valuebitwise boolean and of const to the data stream
gr::blocks::and_const_ii_impl
gr::blocks::and_const_ssOutput_N = input_N & valuebitwise boolean and of const to the data stream
gr::blocks::and_const_ss_impl
gr::blocks::and_iiOutput = input_0 & input_1 & , ... & input_N)bitwise boolean and across all input streams
gr::blocks::and_ii_impl
gr::blocks::and_ssOutput = input_0 & input_1 & , ... & input_N)bitwise boolean and across all input streams
gr::blocks::and_ss_impl
gr::blocks::annotator_1to11-to-1 stream annotator testing block. FOR TESTING PURPOSES ONLY
gr::blocks::annotator_1to1_impl
gr::blocks::annotator_alltoallAll-to-all stream annotator testing block. FOR TESTING PURPOSES ONLY
gr::blocks::annotator_alltoall_impl
gr::blocks::annotator_rawRaw stream annotator testing block
gr::blocks::annotator_raw_impl
gr::blocks::argmax_fsCompares vectors from multiple streams and determines the index in the vector and stream number where the maximum value occurred
gr::blocks::argmax_fs_impl
gr::blocks::argmax_isCompares vectors from multiple streams and determines the index in the vector and stream number where the maximum value occurred
gr::blocks::argmax_is_impl
gr::blocks::argmax_ssCompares vectors from multiple streams and determines the index in the vector and stream number where the maximum value occurred
gr::blocks::argmax_ss_impl
atsc_bit_timing_loopATSC BitTimingLoop3This class accepts a single real input and produces two outputs, the raw symbol (float) and the tag (atsc_syminfo)
atsc_data_segment832 3 bit symbols. The low 3 bits in the byte hold the symbol
atsc_deinterleaverDeinterleave RS encoded ATSC data ( atsc_mpeg_packet_rs_encoded --> atsc_mpeg_packet_rs_encoded)input: atsc_mpeg_packet_rs_encoded; output: atsc_mpeg_packet_rs_encoded
atsc_depadDepad mpeg ts packets from 256 byte atsc_mpeg_packet to 188 byte charinput: atsc_mpeg_packet; output: unsigned char
atsc_derandomizer"dewhiten" incoming mpeg transport stream packetsinput: atsc_mpeg_packet_no_sync; output: atsc_mpeg_packet;
atsc_ds_to_softdsDebug glue routine (atsc_data_segment --> atsc_soft_data_segment)input: atsc_data_segment; output: atsc_soft_data_segment
atsc_equalizerATSC equalizer (float,syminfo --> float,syminfo)first inputs are data samples, second inputs are tags. first outputs are equalized data samples, second outputs are tags
atsc_field_sync_demuxATSC Field Sync Demux
atsc_field_sync_muxInsert ATSC Field Syncs as required (atsc_data_segment --> atsc_data_segment)input: atsc_data_segment; output: atsc_data_segment
atsc_fpllATSC FPLL (2nd Version)A/D --> GrFIRfilterFFF ----> GrAtscFPLL ---->
atsc_fs_checkerATSC field sync checker (float,syminfo --> float,syminfo)first output is delayed version of input. second output is set of tags, one-for-one with first output
atsc_interleaverInterleave RS encoded ATSC data ( atsc_mpeg_packet_rs_encoded --> atsc_mpeg_packet_rs_encoded)*input: atsc_mpeg_packet_rs_encoded; output: atsc_mpeg_packet_rs_encoded
atsc_mpeg_packet
atsc_mpeg_packet_no_sync
atsc_mpeg_packet_rs_encoded
atsc_padPad mpeg ts packets from 188 byte char to to 256 byte atsc_mpeg_packetinput: unsigned char; output: atsc_mpeg_packet
atsc_randomizer"Whiten" incoming mpeg transport stream packetsinput: atsc_mpeg_packet; output: atsc_mpeg_packet_no_sync
atsc_root_raised_cosine
atsc_root_raised_cosine_bandpass
atsc_rs_decoderReed-Solomon decoder for ATSCinput: atsc_mpeg_packet_rs_encoded; output: atsc_mpeg_packet_no_sync
atsc_rs_encoderReed-Solomon encoder for ATSCinput: atsc_mpeg_packet_no_sync; output: atsc_mpeg_packet_rs_encoded
atsc_soft_data_segment
atsc_trellis_encoderATSC 12-way interleaved trellis encoder (atsc_mpeg_packet_rs_encoded --> atsc_data_segment)input: atsc_mpeg_packet_rs_encoded; output: atsc_data_segment
atsc_viterbi_decoderATSC 12-way interleaved viterbi decoder (atsc_soft_data_segment --> atsc_mpeg_packet_rs_encoded)input: atsc_soft_data_segment; output: atsc_mpeg_packet_rs_encoded
atsc_vsbtx_lp
atsci_basic_trellis_encoderATSC trellis encoder building block
atsci_data_deinterleaverAtsc convolutional data deinterleaver
atsci_data_interleaverAtsc convolutional data interleaver
atsci_equalizerAbstract base class for ATSC equalizer
atsci_equalizer_lms
atsci_equalizer_lms2
atsci_equalizer_nop
atsci_exp2_lp
atsci_fake_single_viterbiSingle channel viterbi decoder
atsci_fs_checkerAbstract base class for ATSC field sync checker
atsci_fs_checker_naiveNaive concrete implementation of field sync checker
atsci_fs_correlatorAbstract base class for ATSC field sync correlator
atsci_fs_correlator_naiveNaive concrete implementation of field sync correlator
atsci_interpolatorInterpolator control for segment and symbol sync recovery
atsci_randomizerATSC data "whitener"
atsci_reed_solomonATSC Reed-Solomon encoder / decoder
atsci_single_viterbiSingle channel viterbi decoder
atsci_slicer_agcAutomatic Gain Control class for atsc slicer
atsci_sliding_correlatorLook for the PN 511 field sync pattern
atsci_sssrATSC Segment and Symbol Sync Recovery
atsci_trellis_encoderFancy, schmancy 12-way interleaved trellis encoder for ATSC
atsci_viterbi_decoderFancy, schmancy 12-way interleaved viterbi decoder for ATSC
audio_alsa_sinkAudio sink using ALSAThe sink has N input streams of floats, where N depends on the hardware characteristics of the selected device
audio_alsa_sourceAudio source using ALSAThe source has between 1 and N input streams of floats, where N is depends on the hardware characteristics of the selected device
audio_jack_sinkAudio sink using JACKThe sink has one input stream of floats
audio_jack_sourceAudio source using JACKThe source has one input stream of floats
audio_oss_sinkAudio sink using OSSinput signature is one or two streams of floats. Input samples must be in the range [-1,1]
audio_oss_sourceAudio source using OSSOutput signature is one or two streams of floats. Output samples will be in the range [-1,1]
audio_osx_sinkAudio sink using OSXinput signature is one or two streams of floats. Input samples must be in the range [-1,1]
audio_osx_sourceAudio source using OSXInput signature is one or two streams of floats. Samples must be in the range [-1,1]
audio_portaudio_sinkAudio sink using PORTAUDIOInput samples must be in the range [-1,1]
audio_portaudio_sourceAudio source using PORTAUDIOInput samples must be in the range [-1,1]
audio_sinkCreates a sink from an audio device
audio_sourceCreates a source from an audio device
audio_windows_sinkAudio sink using winmm mmsystem (win32 only)input signature is one or two streams of floats. Input samples must be in the range [-1,1]
audio_windows_sourceAudio source using winmm mmsystem (win32 only)Output signature is one or two streams of floats. Output samples will be in the range [-1,1]
gr::blocks::bin_statistics_fControl scanning and record frequency domain statistics
gr::blocks::bin_statistics_f_impl
bit128
gr::blocks::burst_taggerSets a burst on/off tag based on the value of the trigger input
gr::blocks::burst_tagger_impl
gr::filter::channel_modelChannel simulator
gr::filter::channel_model_impl
gr::blocks::char_to_floatConvert stream of chars to a stream of float
gr::blocks::char_to_float_impl
gr::blocks::char_to_shortConvert stream of chars to a stream of short
gr::blocks::char_to_short_impl
gr::blocks::check_lfsr_32k_sSink that checks if its input stream consists of a lfsr_32k sequence
gr::blocks::check_lfsr_32k_s_impl
circular_buffer< T >
CODEC2
comedi_sink_sSink using COMEDI
comedi_source_sSource using COMEDI
COMP
gr::blocks::complex_to_argComplex in, arg out (float)
gr::blocks::complex_to_arg_impl
gr::blocks::complex_to_floatConvert a stream of gr_complex to 1 or 2 streams of float
gr::blocks::complex_to_float_impl
gr::blocks::complex_to_imagComplex in, imag out (float)
gr::blocks::complex_to_imag_impl
gr::blocks::complex_to_interleaved_shortConvert stream of complex to a stream of interleaved shorts
gr::blocks::complex_to_interleaved_short_impl
gr::blocks::complex_to_magComplex in, magnitude out (float)
gr::blocks::complex_to_mag_impl
gr::blocks::complex_to_mag_squaredComplex in, magnitude squared out (float)
gr::blocks::complex_to_mag_squared_impl
gr::blocks::complex_to_realComplex in, real out (float)
gr::blocks::complex_to_real_impl
gr::blocks::conjugate_ccOutput = complex conjugate of input
gr::blocks::conjugate_cc_impl
gr::blocks::control_loop
convolutional_interleaver< symbol_type >Template class for generic convolutional interleaver
gr::blocks::copyOutput[i] = input[i]
gr::blocks::copy_impl
gr::analog::cpfsk_bcPerform continuous phase 2-level frequency shift keying modulation on an input stream of unpacked bits
gr::analog::cpfsk_bc_impl
gr::analog::cpm
gr::analog::ctcss_squelch_ffGate or zero output if ctcss tone not present
gr::analog::ctcss_squelch_ff_impl
gr::filter::dc_blocker_ccComputationally efficient controllable DC blocker
gr::filter::dc_blocker_cc_impl
gr::filter::dc_blocker_ffComputationally efficient controllable DC blocker
gr::filter::dc_blocker_ff_impl
gr::blocks::deinterleaveDeinterleave a single input into N outputs
gr::blocks::deinterleave_impl
gr::blocks::delayDelay the input by a certain number of samples
gr::blocks::delay_impl
digital_additive_scrambler_bb
digital_binary_slicer_fbSlice float binary symbol outputting 1 bit output
digital_bytes_to_symsConvert stream of bytes to stream of +/- 1 symbols
digital_chunks_to_symbols_bcMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex constellation points in D dimensions (D = 1 by default)
digital_chunks_to_symbols_bfMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex constellation points in D dimensions (D = 1 by default)
digital_chunks_to_symbols_icMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex constellation points in D dimensions (D = 1 by default)
digital_chunks_to_symbols_ifMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex constellation points in D dimensions (D = 1 by default)
digital_chunks_to_symbols_scMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex constellation points in D dimensions (D = 1 by default)
digital_chunks_to_symbols_sfMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex constellation points in D dimensions (D = 1 by default)
digital_clock_recovery_mm_ccMueller and Müller (M&M) based clock recovery block with complex input, complex output
digital_clock_recovery_mm_ffMueller and Müller (M&M) based clock recovery block with float input, float output
digital_cma_equalizer_ccImplements constant modulus adaptive filter on complex stream
digital_constellationAn abstracted constellation objectThe constellation objects hold the necessary information to pass around constellation information for modulators and demodulators. These objects contain the mapping between the bits and the constellation points used to represent them as well as methods for slicing the symbol space. Various implementations are possible for efficiency and ease of use
digital_constellation_8pskDigital constellation for 8PSK
digital_constellation_bpskDigital constellation for BPSK
digital_constellation_calcdistCalculate Euclidian distance for any constellationConstellation which calculates the distance to each point in the constellation for decision making. Inefficient for large constellations
digital_constellation_decoder_cbConstellation Decoder
digital_constellation_dqpskDigital constellation for DQPSK
digital_constellation_expl_rect
digital_constellation_pskDigital_constellation_pskConstellation space is divided into pie slices sectors
digital_constellation_qpskDigital constellation for QPSK
digital_constellation_receiver_cbThis block does fine-phase and frequency locking and decision making
digital_constellation_rect
digital_constellation_sectorSectorized digital constellationConstellation space is divided into sectors. Each sector is associated with the nearest constellation point
digital_correlate_access_code_bbExamine input for specified access code, one bit at a time
digital_correlate_access_code_tag_bbExamine input for specified access code, one bit at a time.input: stream of bits, 1 bit per input byte (data in LSB) output: unaltered stream of bits (plus tags)
sssr::digital_correlatorDigital correlator for 1001 and 0110 patterns
digital_costas_loop_ccA Costas loop carrier recovery module
digital_cpmmod_bcGeneric CPM modulator
digital_crc32_bbByte-stream CRC block
digital_descrambler_bb
digital_diff_decoder_bbY[0] = (x[0] - x[-1]) % M
digital_diff_encoder_bbY[0] = (x[0] + y[-1]) % M
digital_diff_phasor_ccDifferential decoding based on phase change
digital_fll_band_edge_ccFrequency Lock Loop using band-edge filters
digital_framer_sink_1Given a stream of bits and access_code flags, assemble packets
digital_glfsr_source_bGalois LFSR pseudo-random source
digital_glfsr_source_fGalois LFSR pseudo-random source generating float outputs -1.0 - 1.0
digital_gmskmod_bcGMSK modulator
digital_impl_glfsrGalois Linear Feedback Shift Register using specified polynomial maskGenerates a maximal length pseudo-random sequence of length 2^degree-1
digital_impl_mpsk_snr_estA parent class for SNR estimators, specifically for M-PSK signals in AWGN channels
digital_impl_mpsk_snr_est_m2m4SNR Estimator using 2nd and 4th-order moments
digital_impl_mpsk_snr_est_simpleSNR Estimator using simple mean/variance estimates
digital_impl_mpsk_snr_est_skewSNR Estimator using skewness correction
digital_impl_mpsk_snr_est_svrSignal-to-Variation Ratio SNR Estimator
digital_impl_snr_est_m2m4SNR Estimator using 2nd and 4th-order moments
digital_kurtotic_equalizer_ccImplements a kurtosis-based adaptive equalizer on complex stream
digital_lms_dd_equalizer_ccLeast-Mean-Square Decision Directed Equalizer (complex in/out)
digital_map_bbOutput[i] = map[input[i]]
digital_mpsk_receiver_ccThis block takes care of receiving M-PSK modulated signals through phase, frequency, and symbol synchronization
digital_mpsk_snr_est_ccA block for computing SNR of a signal
digital_ofdm_carrier_allocator_cvcCreate frequency domain OFDM symbols from complex values, add pilots.This block turns a stream of complex, scalar modulation symbols into vectors which are the input for an IFFT in an OFDM transmitter. It also supports the possibility of placing pilot symbols onto the carriers
digital_ofdm_chanest_vcvcEstimate channel and coarse frequency offset for OFDM from preamblesInput: OFDM symbols (in frequency domain). The first one (or two) symbols are expected to be synchronisation symbols, which are used to estimate the coarse freq offset and the initial equalizer taps (these symbols are removed from the stream). The following n_data_symbols are passed through unmodified (the actual equalisation must be done elsewhere). Output: The data symbols, without the synchronisation symbols. The first data symbol passed through has two tags: 'ofdm_sync_carr_offset' (integer), the coarse frequency offset as number of carriers, and 'ofdm_sync_eq_taps' (complex vector). Any tags attached to the synchronisation symbols are attached to the first data symbol. All other tags are propagated as expected
digital_ofdm_cyclic_prefixerAdds a cyclic prefix and performs pulse shaping on OFDM symbols.Input: OFDM symbols (in the time domain, i.e. after the IFFT). Optionally, entire frames can be processed. In this case, len_tag_key must be specified which holds the key of the tag that denotes how many OFDM symbols are in a frame. Output: A stream of (scalar) complex symbols, which include the cyclic prefix and the pulse shaping. Note: If complete frames are processed, and rolloff_len is greater than zero, the final OFDM symbol is followed by the delay line of the pulse shaping
digital_ofdm_equalizer_1d_pilots
digital_ofdm_equalizer_base
digital_ofdm_equalizer_simpledfe
digital_ofdm_equalizer_static
digital_ofdm_frame_acquisitionTake a vector of complex constellation points in from an FFT and performs a correlation and equalization.This block takes the output of an FFT of a received OFDM symbol and finds the start of a frame based on two known symbols. It also looks at the surrounding bins in the FFT output for the correlation in case there is a large frequency shift in the data. This block assumes that the fine frequency shift has already been corrected and that the samples fall in the middle of one FFT bin
digital_ofdm_frame_sinkTakes an OFDM symbol in, demaps it into bits of 0's and 1's, packs them into packets, and sends to to a message queue sink.NOTE: The mod input parameter simply chooses a pre-defined demapper/slicer. Eventually, we want to be able to pass in a reference to an object to do the demapping and slicing for a given modulation type
digital_ofdm_insert_preambleInsert "pre-modulated" preamble symbols before each payload
digital_ofdm_mapper_bcvTake a stream of bytes in and map to a vector of complex constellation points suitable for IFFT input to be used in an ofdm modulator. Abstract class must be subclassed with specific mapping
digital_ofdm_samplerDoes the rest of the OFDM stuff
digital_ofdm_sync_sc_cfbSchmidl & Cox synchronisation for OFDM
digital_packet_sinkProcess received bits looking for packet sync, header, and process bits into packet
digital_pfb_clock_sync_ccfTiming synchronizer using polyphase filterbanks
digital_pfb_clock_sync_fffTiming synchronizer using polyphase filterbanks
digital_pn_correlator_ccPN code sequential search correlatorReceives complex baseband signal, outputs complex correlation against reference PN code, one sample per PN code period. The PN sequence is generated using a GLFSR
digital_probe_density_b
digital_probe_mpsk_snr_est_cA probe for computing SNR of a signal
digital_scrambler_bb
digital_simple_correlatorInverse of simple_framer (more or less)
digital_simple_framerAdd sync field, seq number and command field to payload
gr::blocks::divide_ccOutput = input_0 / input_1 / input_x ...)
gr::blocks::divide_cc_impl
gr::blocks::divide_ffOutput = input_0 / input_1 / input_x ...)
gr::blocks::divide_ff_impl
gr::blocks::divide_iiOutput = input_0 / input_1 / input_x ...)
gr::blocks::divide_ii_impl
gr::blocks::divide_ssOutput = input_0 / input_1 / input_x ...)
gr::blocks::divide_ss_impl
gr::analog::dpll_bbDetect the peak of a signal
gr::analog::dpll_bb_impl
gr::blocks::endian_swapConvert stream of items into thier byte swapped version
gr::blocks::endian_swap_impl
FCD_CAPS_STRUCTFCD capabilities that depend on both hardware and firmware
fcd_source_cFuncube Dongle source block
fcd_source_c_impl
gr::analog::feedforward_agc_ccNon-causal AGC which computes required gain based on max absolute value over nsamples
gr::analog::feedforward_agc_cc_impl
gr::fft::fft_complexFFT: complex in, complex out
gr::filter::kernel::fft_filter_cccFast FFT filter with gr_complex input, gr_complex output and gr_complex taps
gr::filter::fft_filter_cccFast FFT filter with gr_complex input, gr_complex output and gr_complex taps
gr::filter::fft_filter_ccc_impl
gr::filter::kernel::fft_filter_fffFast FFT filter with float input, float output and float taps
gr::filter::fft_filter_fffFast FFT filter with float input, float output and float taps
gr::filter::fft_filter_fff_impl
gr::fft::fft_real_fwdFFT: real in, complex out
gr::fft::fft_real_revFFT: complex in, float out
gr::fft::fft_vccCompute forward or reverse FFT. complex vector in / complex vector out
gr::fft::fft_vcc_fftw
gr::fft::fft_vfcCompute forward or reverse FFT. float vector in / complex vector out
gr::fft::fft_vfc_fftw
gr::blocks::file_descriptor_sinkWrite stream to file descriptor
gr::blocks::file_descriptor_sink_impl
gr::blocks::file_descriptor_sourceRead stream from file descriptor
gr::blocks::file_descriptor_source_impl
gr::blocks::file_meta_sinkWrite stream to file with meta-data headers
gr::blocks::file_meta_sink_impl
gr::blocks::file_meta_sourceReads stream from file with meta-data headers. Headers are parsed into tags
gr::blocks::file_meta_source_impl
gr::blocks::file_sinkWrite stream to file
gr::blocks::file_sink_baseCommon base class for file sinks
gr::blocks::file_sink_impl
gr::blocks::file_sourceRead stream from file
gr::blocks::file_source_impl
gr::filter::filter_delay_fcFilter-Delay Combination Block
gr::filter::filter_delay_fc_impl
gr::filter::fir_filter_cccFIR filter with gr_complex input, gr_complex output, and gr_complex taps
gr::filter::kernel::fir_filter_ccc
gr::filter::fir_filter_ccc_impl
gr::filter::fir_filter_ccfFIR filter with gr_complex input, gr_complex output, and float taps
gr::filter::kernel::fir_filter_ccf
gr::filter::fir_filter_ccf_impl
gr::filter::fir_filter_fccFIR filter with float input, gr_complex output, and gr_complex taps
gr::filter::kernel::fir_filter_fcc
gr::filter::fir_filter_fcc_impl
gr::filter::fir_filter_fffFIR filter with float input, float output, and float taps
gr::filter::kernel::fir_filter_fff
gr::filter::fir_filter_fff_impl
gr::filter::fir_filter_fsfFIR filter with float input, short output, and float taps
gr::filter::kernel::fir_filter_fsf
gr::filter::fir_filter_fsf_impl
gr::filter::fir_filter_sccFIR filter with short input, gr_complex output, and gr_complex taps
gr::filter::kernel::fir_filter_scc
gr::filter::fir_filter_scc_impl
gr::filter::kernel::fir_filter_with_buffer_cccFIR with internal buffer for gr_complex input, gr_complex output and gr_complex taps
gr::filter::kernel::fir_filter_with_buffer_ccfFIR with internal buffer for gr_complex input, gr_complex output and gr_complex taps
gr::filter::kernel::fir_filter_with_buffer_fffFIR with internal buffer for float input, float output and float taps
gr::filter::firdesFinite Impulse Response (FIR) filter design functions
flex_mode
gr::blocks::float_to_charConvert stream of floats to a stream of char
gr::blocks::float_to_char_impl
gr::blocks::float_to_complexOne or two floats in, complex out
gr::blocks::float_to_complex_impl
gr::blocks::float_to_intConvert stream of floats to a stream of ints
gr::blocks::float_to_int_impl
gr::blocks::float_to_shortConvert stream of floats to a stream of shorts
gr::blocks::float_to_short_impl
gr::blocks::float_to_ucharConvert stream of floats to a stream of unsigned chars
gr::blocks::float_to_uchar_impl
gr::analog::fmdet_cfImplements an IQ slope detector
gr::analog::fmdet_cf_impl
gr::filter::fractional_interpolator_ccInterpolating MMSE filter with complex input, complex output
gr::filter::fractional_interpolator_cc_impl
gr::filter::fractional_interpolator_ffInterpolating MMSE filter with float input, float output
gr::filter::fractional_interpolator_ff_impl
gr::filter::fractional_resampler_ccResampling MMSE filter with complex input, complex output
gr::filter::fractional_resampler_cc_impl
gr::filter::fractional_resampler_ffResampling MMSE filter with float input, float output
gr::filter::fractional_resampler_ff_impl
gr::filter::freq_xlating_fir_filter_cccFIR filter combined with frequency translation with gr_complex input, gr_complex output and gr_complex taps
gr::filter::freq_xlating_fir_filter_ccc_impl
gr::filter::freq_xlating_fir_filter_ccfFIR filter combined with frequency translation with gr_complex input, gr_complex output and float taps
gr::filter::freq_xlating_fir_filter_ccf_impl
gr::filter::freq_xlating_fir_filter_fccFIR filter combined with frequency translation with float input, gr_complex output and gr_complex taps
gr::filter::freq_xlating_fir_filter_fcc_impl
gr::filter::freq_xlating_fir_filter_fcfFIR filter combined with frequency translation with float input, gr_complex output and float taps
gr::filter::freq_xlating_fir_filter_fcf_impl
gr::filter::freq_xlating_fir_filter_sccFIR filter combined with frequency translation with short input, gr_complex output and gr_complex taps
gr::filter::freq_xlating_fir_filter_scc_impl
gr::filter::freq_xlating_fir_filter_scfFIR filter combined with frequency translation with short input, gr_complex output and float taps
gr::filter::freq_xlating_fir_filter_scf_impl
gr::analog::frequency_modulator_fcFrequency modulator block
gr::analog::frequency_modulator_fc_impl
fsmFinite State Machine Specification class.An instance of this class represents a finite state machine specification (FSMS) rather than the FSM itself. It particular the state of the FSM is not stored within an instance of this class
g72x_state
gr::fft::goertzelImplements Goertzel single-bin DFT calculation
gr::fft::goertzel_fcGoertzel single-bin DFT calculation
gr::fft::goertzel_fc_impl
gr_adaptive_fir_cccAdaptive FIR filter with gr_complex input, gr_complex output and float taps
gr_adaptive_fir_ccfAdaptive FIR filter with gr_complex input, gr_complex output and float taps
gr_add_ccOutput = sum (input_0, input_1, ...)Add across all input streams
gr_add_const_bbOutput = input + constant
gr_add_const_ccOutput = input + constant
gr_add_const_ffOutput = input + constant
gr_add_const_iiOutput = input + constant
gr_add_const_sfOutput = input + constant
gr_add_const_ssOutput = input + constant
gr_add_const_vccOutput vector = input vector + constant vector
gr_add_const_vffOutput vector = input vector + constant vector
gr_add_const_viiOutput vector = input vector + constant vector
gr_add_const_vssOutput vector = input vector + constant vector
gr_add_ffAdd streams of complex values
gr_add_iiOutput = sum (input_0, input_1, ...)Add across all input streams
gr_add_ssOutput = sum (input_0, input_1, ...)Add across all input streams
gr_additive_scrambler_bb
gr_agc2_ccHigh performance Automatic Gain Control class
gr_agc2_ffHigh performance Automatic Gain Control class
gr_agc_ccHigh performance Automatic Gain Control class
gr_agc_ffHigh performance Automatic Gain Control class
gr_align_on_samplenumbers_ss
gr_and_bbOutput = input_0 & input_1 & , ... & input_N)bitwise boolean and across all input streams
gr_and_const_bbOutput_N = input_N & valuebitwise boolean and of const to the data stream
gr_and_const_iiOutput_N = input_N & valuebitwise boolean and of const to the data stream
gr_and_const_ssOutput_N = input_N & valuebitwise boolean and of const to the data stream
gr_and_iiOutput = input_0 & input_1 & , ... & input_N)bitwise boolean and across all input streams
gr_and_ssOutput = input_0 & input_1 & , ... & input_N)bitwise boolean and across all input streams
gr_annotator_1to11-to-1 stream annotator testing block. FOR TESTING PURPOSES ONLY
gr_annotator_alltoallAll-to-all stream annotator testing block. FOR TESTING PURPOSES ONLY
gr_annotator_rawRaw stream annotator testing block
gr_argmax_fs
gr_argmax_is
gr_argmax_ss
gr_base_error_handler
gr_basic_blockThe abstract base class for all signal processing blocks.Basic blocks are the bare abstraction of an entity that has a name, a set of inputs and outputs, and a message queue. These are never instantiated directly; rather, this is the abstract parent class of both gr_hier_block, which is a recursive container, and gr_block, which implements actual signal processing functions
gr_bin_statistics_fControl scanning and record frequency domain statistics
gr_blockThe abstract base class for all 'terminal' processing blocks.A signal processing flow is constructed by creating a tree of hierarchical blocks, which at any level may also contain terminal nodes that actually implement signal processing functions. This is the base class for all such leaf nodes
gr_block_detailImplementation details to support the signal processing abstractionThis class contains implementation detail that should be "out of sight" of almost all users of GNU Radio. This decoupling also means that we can make changes to the guts without having to recompile everything
gr_block_executorManage the execution of a single block
gr_block_gateway
gr_block_gw_message_type
gr_block_registry
gr_bufferSingle writer, multiple reader fifo
gr_buffer_readerHow we keep track of the readers of a gr_buffer
gr_burst_taggerOutput[i] = input[i]
gr_bytes_to_symsConvert stream of bytes to stream of +/- 1 symbols
gr_channel_modelChannel simulator
gr_char_to_floatConvert stream of chars to a stream of float
gr_char_to_shortConvert stream of chars to a stream of float
gr_check_counting_sSink that checks if its input stream consists of a counting sequence
gr_check_lfsr_32k_sSink that checks if its input stream consists of a lfsr_32k sequence
gr_chunks_to_symbols_bcMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex onstellation points.in D dimensions (D = 1 by default)input: stream of unsigned char; output: stream of gr_complex
gr_chunks_to_symbols_bfMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex onstellation points.in D dimensions (D = 1 by default)input: stream of unsigned char; output: stream of float
gr_chunks_to_symbols_icMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex onstellation points.in D dimensions (D = 1 by default)input: stream of int; output: stream of gr_complex
gr_chunks_to_symbols_ifMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex onstellation points.in D dimensions (D = 1 by default)input: stream of int; output: stream of float
gr_chunks_to_symbols_scMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex onstellation points.in D dimensions (D = 1 by default)input: stream of short; output: stream of gr_complex
gr_chunks_to_symbols_sfMap a stream of symbol indexes (unpacked bytes or shorts) to stream of float or complex onstellation points.in D dimensions (D = 1 by default)input: stream of short; output: stream of float
gr_circular_file
gr_complex_to_argComplex in, angle out (float)
gr_complex_to_floatConvert a stream of gr_complex to 1 or 2 streams of float
gr_complex_to_imagComplex in, imaginary out (float)
gr_complex_to_interleaved_shortConvert stream of complex to a stream of interleaved shorts
gr_complex_to_magComplex in, magnitude out (float)
gr_complex_to_mag_squaredComplex in, magnitude squared out (float)
gr_complex_to_realComplex in, real out (float)
gr_conjugate_ccOutput = complex conjugate of input
gr_copyOutput[i] = input[i]
gr_correlate_access_code_tag_bbExamine input for specified access code, one bit at a time
gr_cpfsk_bcPerform continuous phase 2-level frequency shift keying modulation on an input stream of unpacked bits
gr_cpm
gr_cpu
gr_ctcss_squelch_ffGate or zero output if ctcss tone not present
gr_dc_blocker_ccComputationally efficient controllable DC blocker
gr_dc_blocker_ffComputationally efficient controllable DC blocker
gr_decode_ccsds_27_fbA rate 1/2, k=7 convolutional decoder for the CCSDS standard
gr_deinterleaveDeinterleave a single input into N outputs
gr_delayDelay the input by a certain number of samples
gr_descrambler_bb
gr_diff_decoder_bbY[0] = (x[0] - x[-1]) % M
gr_diff_encoder_bbY[0] = (x[0] + y[-1]) % M
gr_diff_phasor_cc
gr_dispatcherInvoke callbacks based on select
gr_divide_ccOutput = input_0 / input_1 / input_x ...)Divide across all input streams
gr_divide_ffOutput = input_0 / input_1 / input_x ...)Divide across all input streams
gr_divide_iiOutput = input_0 / input_1 / input_x ...)Divide across all input streams
gr_divide_ssOutput = input_0 / input_1 / input_x ...)Divide across all input streams
gr_dpll_bbDetect the peak of a signal
gr_edgeClass representing a connection between to graph endpoints
gr_encode_ccsds_27_bbA rate 1/2, k=7 convolutional encoder for the CCSDS standard
gr_endian_swapConvert stream of items into thier byte swapped version
gr_endpointClass representing a specific input or output graph endpoint
gr_error_handlerAbstract error handler
gr_fake_channel_decoder_ppRemove fake padding from packet
gr_fake_channel_encoder_ppPad packet with alternating 1,0 pattern
gr_fastnoise_source_cRandom number source
gr_fastnoise_source_fRandom number source
gr_fastnoise_source_iRandom number source
gr_fastnoise_source_sRandom number source
gr_feedforward_agc_ccNon-causal AGC which computes required gain based on max absolute value over nsamples
gr_fevalBase class for evaluating a function: void -> voidThis class is designed to be subclassed in Python or C++ and is callable from both places. It uses SWIG's "director" feature to implement the magic. It's slow. Don't use it in a performance critical path
gr_feval_ccBase class for evaluating a function: complex -> complexThis class is designed to be subclassed in Python or C++ and is callable from both places. It uses SWIG's "director" feature to implement the magic. It's slow. Don't use it in a performance critical path
gr_feval_ddBase class for evaluating a function: double -> doubleThis class is designed to be subclassed in Python or C++ and is callable from both places. It uses SWIG's "director" feature to implement the magic. It's slow. Don't use it in a performance critical path
gr_feval_llBase class for evaluating a function: long -> longThis class is designed to be subclassed in Python or C++ and is callable from both places. It uses SWIG's "director" feature to implement the magic. It's slow. Don't use it in a performance critical path
gr_feval_pBase class for evaluating a function: pmt -> voidThis class is designed to be subclassed in Python or C++ and is callable from both places. It uses SWIG's "director" feature to implement the magic. It's slow. Don't use it in a performance critical path
gr_fft_filter_cccFast FFT filter with gr_complex input, gr_complex output and gr_complex taps
gr_fft_filter_fffFast FFT filter with float input, float output and float taps
gr_fft_vccCompute forward or reverse FFT. complex vector in / complex vector out
gr_fft_vcc_fftwCompute forward or reverse FFT. complex vector in / complex vector out
gr_fft_vfcCompute forward FFT. float vector in / complex vector out
gr_file_descriptor_sinkWrite stream to file descriptor
gr_file_descriptor_sourceRead stream from file descriptor
gr_file_error_handler
gr_file_sinkWrite stream to file
gr_file_sink_baseCommon base class for file sinks
gr_file_sourceRead stream from file
gr_filter_delay_fcFilter-Delay Combination Block
gr_fir_cccAbstract class for FIR with gr_complex input, gr_complex output and gr_complex tapsThis is the abstract class for a Finite Impulse Response filter
gr_fir_ccc_3dnow3DNow! version of gr_fir_ccc
gr_fir_ccc_3dnowext
gr_fir_ccc_genericConcrete class for generic implementation of FIR with gr_complex input, gr_complex output and gr_complex taps
gr_fir_ccc_info
gr_fir_ccc_simdCommon base class for SIMD versions of gr_fir_cccThis base class handles alignment issues common to SSE and 3DNOW subclasses
gr_fir_ccc_sseSSE version of gr_fir_ccc
gr_fir_ccfAbstract class for FIR with gr_complex input, gr_complex output and float tapsThis is the abstract class for a Finite Impulse Response filter
gr_fir_ccf_3dnow3DNow! version of gr_fir_ccf
gr_fir_ccf_armv7_aArmv7_a using NEON coprocessor version of gr_fir_ccf
gr_fir_ccf_genericConcrete class for generic implementation of FIR with gr_complex input, gr_complex output and float taps
gr_fir_ccf_info
gr_fir_ccf_simdCommon base class for SIMD versions of gr_fir_ccfThis base class handles alignment issues common to SSE and 3DNOW subclasses
gr_fir_ccf_sseSSE version of gr_fir_ccf
gr_fir_fccAbstract class for FIR with float input, gr_complex output and gr_complex tapsThis is the abstract class for a Finite Impulse Response filter
gr_fir_fcc_3dnow3DNow! version of gr_fir_fcc
gr_fir_fcc_genericConcrete class for generic implementation of FIR with float input, gr_complex output and gr_complex taps
gr_fir_fcc_info
gr_fir_fcc_simdCommon base class for SIMD versions of gr_fir_fccThis base class handles alignment issues common to SSE and 3DNOW subclasses
gr_fir_fcc_sseSSE version of gr_fir_fcc
gr_fir_fffAbstract class for FIR with float input, float output and float tapsThis is the abstract class for a Finite Impulse Response filter
gr_fir_fff_3dnow3DNow! version of gr_fir_fff
gr_fir_fff_altivecAltivec version of gr_fir_fff
gr_fir_fff_armv7_aArmv7_a using NEON coprocessor version of gr_fir_fff
gr_fir_fff_genericConcrete class for generic implementation of FIR with float input, float output and float taps
gr_fir_fff_info
gr_fir_fff_simdCommon base class for SIMD versions of gr_fir_fffThis base class handles alignment issues common to SSE and 3DNOW subclasses
gr_fir_fff_sseSSE version of gr_fir_fff
gr_fir_filter_cccFIR filter with gr_complex input, gr_complex output and gr_complex taps
gr_fir_filter_ccfFIR filter with gr_complex input, gr_complex output and float taps
gr_fir_filter_fccFIR filter with float input, gr_complex output and gr_complex taps
gr_fir_filter_fffFIR filter with float input, float output and float taps
gr_fir_filter_fsfFIR filter with float input, short output and float taps
gr_fir_filter_sccFIR filter with short input, gr_complex output and gr_complex taps
gr_fir_fsfAbstract class for FIR with float input, short output and float tapsThis is the abstract class for a Finite Impulse Response filter
gr_fir_fsf_3dnow3DNow! version of gr_fir_fsf
gr_fir_fsf_genericConcrete class for generic implementation of FIR with float input, short output and float taps
gr_fir_fsf_info
gr_fir_fsf_simdCommon base class for SIMD versions of gr_fir_fsfThis base class handles alignment issues common to SSE and 3DNOW subclasses
gr_fir_fsf_sseSSE version of gr_fir_fsf
gr_fir_sccAbstract class for FIR with short input, gr_complex output and gr_complex tapsThis is the abstract class for a Finite Impulse Response filter
gr_fir_scc_3dnow3DNow! version of gr_fir_scc
gr_fir_scc_3dnowext3DNow! Ext version of gr_fir_scc
gr_fir_scc_genericConcrete class for generic implementation of FIR with short input, gr_complex output and gr_complex taps
gr_fir_scc_info
gr_fir_scc_simdCommon base class for SIMD versions of gr_fir_sccThis base class handles alignment issues common to SSE and 3DNOW subclasses
gr_fir_scc_sseSSE version of gr_fir_scc
gr_fir_sysconfigAbstract base class for configuring the automatic selection of the fastest gr_fir for your platform
gr_fir_sysconfig_armv7_a
gr_fir_sysconfig_generic
gr_fir_sysconfig_powerpc
gr_fir_sysconfig_x86
gr_fir_util
gr_firdesFinite Impulse Response (FIR) filter design functions
gr_flat_flowgraphClass specializing gr_flat_flowgraph that has all nodes as gr_blocks, with no hierarchy
gr_float_to_charConvert stream of float to a stream of char
gr_float_to_complexConvert 1 or 2 streams of float to a stream of gr_complex
gr_float_to_intConvert stream of float to a stream of short
gr_float_to_shortConvert stream of float to a stream of short
gr_float_to_ucharConvert stream of float to a stream of unsigned char
gr_flowgraphClass representing a directed, acyclic graph of basic blocks
gr_fmdet_cfImplements an IQ slope detector
gr_fractional_interpolator_ccInterpolating mmse filter with gr_complex input, gr_complex output
gr_fractional_interpolator_ffInterpolating mmse filter with float input, float output
gr_framer_sink_1Given a stream of bits and access_code flags, assemble packets
gr_freq_xlating_fir_filter_cccFIR filter combined with frequency translation with gr_complex input, gr_complex output and gr_complex taps
gr_freq_xlating_fir_filter_ccfFIR filter combined with frequency translation with gr_complex input, gr_complex output and float taps
gr_freq_xlating_fir_filter_fccFIR filter combined with frequency translation with float input, gr_complex output and gr_complex taps
gr_freq_xlating_fir_filter_fcfFIR filter combined with frequency translation with float input, gr_complex output and float taps
gr_freq_xlating_fir_filter_sccFIR filter combined with frequency translation with short input, gr_complex output and gr_complex taps
gr_freq_xlating_fir_filter_scfFIR filter combined with frequency translation with short input, gr_complex output and float taps
gr_frequency_modulator_fcFrequency modulator block
gr_fxptFixed point sine and cosine and friends.fixed pt radians --------- -------- -2**31 -pi 0 0 2**31-1 pi - epsilon
gr_fxpt_ncoNumerically Controlled Oscillator (NCO)
gr_fxpt_vcoVoltage Controlled Oscillator (VCO)
gr_glfsr_source_bGalois LFSR pseudo-random source
gr_glfsr_source_fGalois LFSR pseudo-random source generating float outputs -1.0 - 1.0
gr_goertzel_fcGoertzel single-bin DFT calculation
gr_headCopies the first N items to the output then signals done
gr_hier_block2Hierarchical container class for gr_block's and gr_hier_block2's
gr_hier_block2_detail
gr_hilbert_fcHilbert transformer
gr_histo_sink_fHistogram module
gr_iir_filter_ffdIIR filter with float input, float output and double taps
gr_int_to_floatConvert stream of int to a stream of float
gr_integrate_ccOutput = sum(input[0]...input[n])Integrate successive samples in input stream and decimate
gr_integrate_ffOutput = sum(input[0]...input[n])Integrate successive samples in input stream and decimate
gr_integrate_iiOutput = sum(input[0]...input[n])Integrate successive samples in input stream and decimate
gr_integrate_ssOutput = sum(input[0]...input[n])Integrate successive samples in input stream and decimate
gr_interleaveInterleave N inputs to a single output
gr_interleaved_short_to_complexConvert stream of interleaved shorts to a stream of complex
gr_interp_fir_filter_cccInterpolating FIR filter with gr_complex input, gr_complex output and gr_complex taps
gr_interp_fir_filter_ccfInterpolating FIR filter with gr_complex input, gr_complex output and float taps
gr_interp_fir_filter_fccInterpolating FIR filter with float input, gr_complex output and gr_complex taps
gr_interp_fir_filter_fffInterpolating FIR filter with float input, float output and float taps
gr_interp_fir_filter_fsfInterpolating FIR filter with float input, short output and float taps
gr_interp_fir_filter_sccInterpolating FIR filter with short input, gr_complex output and gr_complex taps
gr_io_signatureI/o signature for input and output ports
gr_iqcomp_cc
gr_keep_m_in_nDecimate a stream, keeping one item out of every n
gr_keep_one_in_nDecimate a stream, keeping one item out of every n
gr_kludge_copyOutput[i] = input[i]
gr_lfsr_32k_source_sLFSR pseudo-random source with period of 2^15 bits (2^11 shorts)
gr_local_sighandlerGet and set signal handler
gr_map_bbOutput[i] = map[input[i]]
gr_max_ff
gr_max_ii
gr_max_ss
gr_messageMessage class
gr_message_burst_sourceTurn received messages into a stream and tag them for UHD to send
gr_message_debugPrint received messages to stdout
gr_message_sinkGather received items into messages and insert into msgq
gr_message_sourceTurn received messages into a stream
gr_message_strobeSend message at defined interval
gr_moving_average_ccOutput is the moving sum of the last N samples, scaled by the scale factor
gr_moving_average_ffOutput is the moving sum of the last N samples, scaled by the scale factor
gr_moving_average_iiOutput is the moving sum of the last N samples, scaled by the scale factor
gr_moving_average_ssOutput is the moving sum of the last N samples, scaled by the scale factor
gr_msg_accepterAccepts messages and inserts them into a message queue, then notifies subclass gr_basic_block there is a message pending
gr_msg_edgeClass representing a msg connection between to graph msg endpoints
gr_msg_endpoint
gr_msg_handlerAbstract class of message handlers
gr_msg_queueThread-safe message queue
gr_multiply_ccMultiply streams of complex values
gr_multiply_conjugate_ccMultiplies a stream by the conjugate of the second stream
gr_multiply_const_ccMultiply stream of complex values with a constant k
gr_multiply_const_ffMultiply stream of float values with a constant k
gr_multiply_const_iiOutput = input * constant
gr_multiply_const_ssOutput = input * constant
gr_multiply_const_vccOutput vector = input vector * constant vector (element-wise)
gr_multiply_const_vffOutput vector = input vector * constant vector (element-wise)
gr_multiply_const_viiOutput vector = input vector * constant vector (element-wise)
gr_multiply_const_vssOutput vector = input vector * constant vector (element-wise)
gr_multiply_ffMultiply streams of complex values
gr_multiply_iiOutput = prod (input_0, input_1, ...)Multiply across all input streams
gr_multiply_ssOutput = prod (input_0, input_1, ...)Multiply across all input streams
gr_mute_ccOutput = input or zero if muted
gr_mute_ffOutput = input or zero if muted
gr_mute_iiOutput = input or zero if muted
gr_mute_ssOutput = input or zero if muted
gr_nco< o_type, i_type >Base class template for Numerically Controlled Oscillator (NCO)
gr_nlog10_ffOutput = n*log10(input) + k
gr_noise_source_cRandom number source
gr_noise_source_fRandom number source
gr_noise_source_iRandom number source
gr_noise_source_sRandom number source
gr_nopDoes nothing. Used for testing only
gr_not_bbOutput = ~input_0bitwise boolean not across input stream
gr_not_iiOutput = ~input_0bitwise boolean not across input stream
gr_not_ssOutput = ~input_0bitwise boolean not across input stream
gr_null_sinkBit bucket
gr_null_sourceA source of zeros
gr_ofdm_bpsk_demapperTake a vector of complex constellation points in from an FFT and demodulate to a stream of bits. Simple BPSK version
gr_ofdm_frame_sink2Takes an OFDM symbol in, demaps it into bits of 0's and 1's, packs them into packets, and sends to to a message queue sink
gr_or_bbOutput = input_0 | input_1 | , ... | input_N)bitwise boolean or across all input streams
gr_or_iiOutput = input_0 | input_1 | , ... | input_N)bitwise boolean or across all input streams
gr_or_ssOutput = input_0 | input_1 | , ... | input_N)bitwise boolean or across all input streams
gr_oscope_gutsGuts of oscilloscope trigger and buffer module
gr_oscope_sink_fBuilding block for python oscilloscope module.Accepts multiple float streams
gr_oscope_sink_xAbstract class for python oscilloscope module.Don't instantiate this. Use gr_oscope_sink_f or gr_oscope_sink_c instead
gr_pa_2x2_phase_combinerPa_2x2 phase combinerAnntenas are arranged like this:
gr_pack_k_bits_bbConverts a stream of bytes with 1 bit in the LSB to a byte with k relevent bits
gr_packed_to_unpacked_bbConvert a stream of packed bytes or shorts to stream of unpacked bytes or shorts.input: stream of unsigned char; output: stream of unsigned char
gr_packed_to_unpacked_iiConvert a stream of packed bytes or shorts to stream of unpacked bytes or shorts.input: stream of int; output: stream of int
gr_packed_to_unpacked_ssConvert a stream of packed bytes or shorts to stream of unpacked bytes or shorts.input: stream of short; output: stream of short
gr_packet_sinkProcess received bits looking for packet sync, header, and process bits into packet
gr_pdu_to_tagged_streamTurn received messages into a stream
gr_peak_detector2_fbDetect the peak of a signal
gr_peak_detector_fbDetect the peak of a signalIf a peak is detected, this block outputs a 1, or it outputs 0's
gr_peak_detector_ibDetect the peak of a signalIf a peak is detected, this block outputs a 1, or it outputs 0's
gr_peak_detector_sbDetect the peak of a signalIf a peak is detected, this block outputs a 1, or it outputs 0's
gr_pfb_arb_resampler_ccfPolyphase filterbank arbitrary resampler with gr_complex input, gr_complex output and float taps
gr_pfb_arb_resampler_fffPolyphase filterbank arbitrary resampler with float input, float output and float taps
gr_pfb_channelizer_ccfPolyphase filterbank channelizer with gr_complex input, gr_complex output and float taps
gr_pfb_clock_sync_ccfTiming synchronizer using polyphase filterbanks
gr_pfb_clock_sync_fffTiming synchronizer using polyphase filterbanks
gr_pfb_decimator_ccfPolyphase filterbank bandpass decimator with gr_complex input, gr_complex output and float taps
gr_pfb_interpolator_ccfPolyphase filterbank interpolator with gr_complex input, gr_complex output and float taps
gr_pfb_synthesizer_ccfPolyphase synthesis filterbank with gr_complex input, gr_complex output and float taps
gr_phase_modulator_fcPhase modulator block output=complex(cos(in*sensitivity),sin(in*sensitivity))
gr_pll_carriertracking_ccImplements a PLL which locks to the input frequency and outputs the input signal mixed with that carrier
gr_pll_freqdet_cfImplements a PLL which locks to the input frequency and outputs an estimate of that frequency. Useful for FM Demod
gr_pll_refout_ccImplements a PLL which locks to the input frequency and outputs a carrier
gr_pn_correlator_ccPN code sequential search correlator
gr_preferences
gr_prefsBase class for representing user preferences a la windows INI files.The real implementation is in Python, and is accessable from C++ via the magic of SWIG directors
gr_probe_avg_mag_sqrd_cCompute avg magnitude squared
gr_probe_avg_mag_sqrd_cfCompute avg magnitude squared
gr_probe_avg_mag_sqrd_fCompute avg magnitude squared
gr_probe_density_b
gr_probe_signal_bSink that allows a sample to be grabbed from Python
gr_probe_signal_cSink that allows a sample to be grabbed from Python
gr_probe_signal_fSink that allows a sample to be grabbed from Python
gr_probe_signal_iSink that allows a sample to be grabbed from Python
gr_probe_signal_sSink that allows a sample to be grabbed from Python
gr_probe_signal_vbSink that allows a sample to be grabbed from Python
gr_probe_signal_vcSink that allows a sample to be grabbed from Python
gr_probe_signal_vfSink that allows a sample to be grabbed from Python
gr_probe_signal_viSink that allows a sample to be grabbed from Python
gr_probe_signal_vsSink that allows a sample to be grabbed from Python
gr_pwr_squelch_ccGate or zero output when input power below threshold
gr_pwr_squelch_ffGate or zero output when input power below threshold
gr_quadrature_demod_cfQuadrature demodulator: complex in, float out
gr_rail_ff
gr_randomPseudo random number generator
gr_random_pduSend message at defined interval
gr_rational_resampler_base_cccRational Resampling Polyphase FIR filter with gr_complex input, gr_complex output and gr_complex taps
gr_rational_resampler_base_ccfRational Resampling Polyphase FIR filter with gr_complex input, gr_complex output and float taps
gr_rational_resampler_base_fccRational Resampling Polyphase FIR filter with float input, gr_complex output and gr_complex taps
gr_rational_resampler_base_fffRational Resampling Polyphase FIR filter with float input, float output and float taps
gr_rational_resampler_base_fsfRational Resampling Polyphase FIR filter with float input, short output and float taps
gr_rational_resampler_base_sccRational Resampling Polyphase FIR filter with short input, gr_complex output and gr_complex taps
gr_regenerate_bbDetect the peak of a signal and repeat every period samples
gr_repeatRepeat a sample 'interp' times in output stream
gr_rms_cfRMS average power
gr_rms_ffRMS average power
gr_rotator
gr_sample_and_hold_bbSample and hold circuitSamples the data stream (input stream 0) and holds the value if the control signal is 1 (intput stream 1)
gr_sample_and_hold_ffSample and hold circuitSamples the data stream (input stream 0) and holds the value if the control signal is 1 (intput stream 1)
gr_sample_and_hold_iiSample and hold circuitSamples the data stream (input stream 0) and holds the value if the control signal is 1 (intput stream 1)
gr_sample_and_hold_ssSample and hold circuitSamples the data stream (input stream 0) and holds the value if the control signal is 1 (intput stream 1)
gr_schedulerAbstract scheduler that takes a flattened flow graph and runs it
gr_scheduler_stsConcrete scheduler that uses the single_threaded_scheduler
gr_scheduler_tpbConcrete scheduler that uses a kernel thread-per-block
gr_scrambler_bb
gr_select_handlerAbstract handler for select based notification
gr_short_to_charConvert stream of short to a stream of float
gr_short_to_floatConvert stream of short to a stream of float
gr_sig_source_cSignal generator with gr_complex output
gr_sig_source_fSignal generator with float output
gr_sig_source_iSignal generator with int output
gr_sig_source_sSignal generator with short output
gr_signalRepresentation of signal
gr_simple_correlatorInverse of gr_simple_framer (more or less)
gr_simple_framerAdd sync field, seq number and command field to payload
gr_simple_squelch_ccSimple squelch block based on average signal power and threshold in dB
gr_single_pole_iir< o_type, i_type, tap_type >Class template for single pole IIR filter
gr_single_pole_iir< gr_complex, i_type, double >
gr_single_pole_iir_filter_ccSingle pole IIR filter with complex input, complex output
gr_single_pole_iir_filter_ffSingle pole IIR filter with float input, float output
gr_single_threaded_schedulerSimple scheduler for stream computations
gr_skipheadSkips the first N items, from then on copies items to the output
gr_socket_pduGather received items into messages and insert into msgq
gr_squelch_base_cc
gr_squelch_base_ff
gr_stream_muxStream muxing block to multiplex many streams into one with a specified format
gr_stream_pdu_baseGather received items into messages and insert into msgq
gr_stream_to_streamsConvert a stream of items into a N streams of items
gr_stream_to_vectorConvert a stream of items into a stream of blocks containing nitems_per_block
gr_streams_to_streamConvert N streams of 1 item into a 1 stream of N items
gr_streams_to_vectorConvert N streams of items to 1 stream of vector length N
gr_stretch_ff
gr_sub_ccOutput = input_0 - input_1 - ...)Subtract across all input streams
gr_sub_ffOutput = input_0 - input_1 - ...)Subtract across all input streams
gr_sub_iiOutput = input_0 - input_1 - ...)Subtract across all input streams
gr_sub_ssOutput = input_0 - input_1 - ...)Subtract across all input streams
gr_sync_blockSynchronous 1:1 input to output with historyOverride work to provide the signal processing implementation
gr_sync_decimatorSynchronous N:1 input to output with historyOverride work to provide the signal processing implementation
gr_sync_interpolatorSynchronous 1:N input to output with historyOverride work to provide the signal processing implementation
gr_tag_debugBit bucket that prints out any tag received
gr_tag_t
gr_tagged_file_sinkWrite stream to file descriptor
gr_tagged_stream_blockBlock that operates on PDUs in form of tagged streamsOverride work to provide the signal processing implementation
gr_tagged_stream_to_pduTurn received messages into a stream
gr_testTest class for testing runtime system (setting up buffers and such.)This block does not do any usefull actual data processing. It just exposes setting all standard block parameters using the contructor or public methods
gr_threshold_ffPlease fix my documentation
gr_throttleThrottle flow of samples such that the average rate does not exceed samples_per_sec
gr_timerImplement timeouts
gr_top_blockTop-level hierarchical block representing a flowgraph
gr_top_block_implAbstract implementation details of gr_top_blockThe actual implementation of gr_top_block. Separate class allows decoupling of changes from dependent classes
gr_tpb_detailUsed by thread-per-block scheduler
gr_tpb_thread_bodyThe body of each thread-per-block thread
gr_transcendentalA block that performs various transcendental math operations
gr_tuntap_pdu
gr_uchar_to_floatConvert stream of unsigned chars to a stream of float
gr_udp_sinkWrite stream to an UDP socket
gr_udp_sourceRead stream from an UDP socket
gr_unpack_k_bits_bbConverts a byte with k relevent bits to k output bytes with 1 bit in the LSB
gr_unpacked_to_packed_bbConvert a stream of unpacked bytes or shorts into a stream of packed bytes or shorts.input: stream of unsigned char; output: stream of unsigned char
gr_unpacked_to_packed_iiConvert a stream of unpacked bytes or shorts into a stream of packed bytes or shorts.input: stream of int; output: stream of int
gr_unpacked_to_packed_ssConvert a stream of unpacked bytes or shorts into a stream of packed bytes or shorts.input: stream of short; output: stream of short
gr_vco< o_type, i_type >Base class template for Voltage Controlled Oscillator (VCO)
gr_vco_fVCO - Voltage controlled oscillatorinput: float stream of control voltages; output: float oscillator output
gr_vector_insert_bSource of unsigned char's that gets its data from a vector
gr_vector_mapMaps elements from a set of input vectors to a set of output vectors
gr_vector_sink_bUnsigned char sink that writes to a vector
gr_vector_sink_cGr_complex sink that writes to a vector
gr_vector_sink_fFloat sink that writes to a vector
gr_vector_sink_iInt sink that writes to a vector
gr_vector_sink_sShort sink that writes to a vector
gr_vector_source_bSource of unsigned char's that gets its data from a vector
gr_vector_source_cSource of gr_complex's that gets its data from a vector
gr_vector_source_fSource of float's that gets its data from a vector
gr_vector_source_iSource of int's that gets its data from a vector
gr_vector_source_sSource of short's that gets its data from a vector
gr_vector_to_streamConvert a stream of blocks of nitems_per_block items into a stream of items
gr_vector_to_streamsConvert 1 stream of vectors of length N to N streams of items
gr_vmcircbufAbstract class to implement doubly mapped virtual memory circular buffers
gr_vmcircbuf_createfilemappingConcrete class to implement circular buffers with mmap and shm_open
gr_vmcircbuf_createfilemapping_factoryConcrete factory for circular buffers built using mmap and shm_open
gr_vmcircbuf_factoryAbstract factory for creating circular buffers
gr_vmcircbuf_mmap_shm_openConcrete class to implement circular buffers with mmap and shm_open
gr_vmcircbuf_mmap_shm_open_factoryConcrete factory for circular buffers built using mmap and shm_open
gr_vmcircbuf_mmap_tmpfileConcrete class to implement circular buffers with mmap and shm_open
gr_vmcircbuf_mmap_tmpfile_factoryConcrete factory for circular buffers built using mmap and shm_open
gr_vmcircbuf_sysconfig
gr_vmcircbuf_sysv_shmConcrete class to implement circular buffers with mmap and shm_open
gr_vmcircbuf_sysv_shm_factoryConcrete factory for circular buffers built using mmap and shm_open
gr_wavfile_sinkWrite stream to a Microsoft PCM (.wav) file
gr_wavfile_sourceRead stream from a Microsoft PCM (.wav) file, output floats
gr_xor_bbOutput = input_0 ^ input_1 ^ , ... ^ input_N)bitwise boolean xor across all input streams
gr_xor_iiOutput = input_0 ^ input_1 ^ , ... ^ input_N)bitwise boolean xor across all input streams
gr_xor_ssOutput = input_0 ^ input_1 ^ , ... ^ input_N)bitwise boolean xor across all input streams
gri_agc2_ccHigh performance Automatic Gain Control class
gri_agc2_ffHigh performance Automatic Gain Control class with attack and decay rate
gri_agc_ccHigh performance Automatic Gain Control class
gri_agc_ffHigh performance Automatic Gain Control class
gri_control_loop
gri_fft_complexFFT: complex in, complex out
gri_fft_filter_ccc_genericFast FFT filter with gr_complex input, gr_complex output and gr_complex taps
gri_fft_filter_ccc_sseFast FFT filter with gr_complex input, gr_complex output and gr_complex taps
gri_fft_filter_fff_generic
gri_fft_filter_fff_sse
gri_fft_plannerExport reference to planner mutex for those apps that want to use FFTW w/o using the gri_fftw* classes
gri_fft_real_fwdFFT: real in, complex out
gri_fft_real_revFFT: complex in, float out
gri_fir_filter_with_buffer_cccFIR with internal buffer for gr_complex input, gr_complex output and gr_complex taps
gri_fir_filter_with_buffer_ccfFIR with internal buffer for gr_complex input, gr_complex output and float taps
gri_fir_filter_with_buffer_fccFIR with internal buffer for float input, gr_complex output and gr_complex taps
gri_fir_filter_with_buffer_fffFIR with internal buffer for float input, float output and float taps
gri_fir_filter_with_buffer_fsfFIR with internal buffer for float input, short output and float taps
gri_fir_filter_with_buffer_sccFIR with internal buffer for short input, gr_complex output and gr_complex taps
gri_glfsrGalois Linear Feedback Shift Register using specified polynomial maskGenerates a maximal length pseudo-random sequence of length 2^degree-1
gri_goertzelImplements Goertzel single-bin DFT calculation
gri_iir< i_type, o_type, tap_type >Base class template for Infinite Impulse Response filter (IIR)
gri_lfsrFibonacci Linear Feedback Shift Register using specified polynomial maskGenerates a maximal length pseudo-random sequence of length 2^degree-1
gri_lfsr_15_1_0Linear Feedback Shift Register using primitive polynomial x^15 + x + 1Generates a maximal length pseudo-random sequence of length 2^15 - 1 bits
gri_lfsr_32kGenerate pseudo-random sequence of length 32768 bits.This is based on gri_lfsr_15_1_0 with an extra 0 added at the end of the sequence
gri_mmse_fir_interpolatorCompute intermediate samples between signal samples x(k*Ts)This implements a Mininum Mean Squared Error interpolator with 8 taps. It is suitable for signals where the bandwidth of interest B = 1/(4*Ts) Where Ts is the time between samples
gri_mmse_fir_interpolator_ccCompute intermediate samples between signal samples x(k*Ts)This implements a Mininum Mean Squared Error interpolator with 8 taps. It is suitable for signals where the bandwidth of interest B = 1/(4*Ts) Where Ts is the time between samples
gsm_state
gr::blocks::headCopies the first N items to the output then signals done
gr::blocks::head_impl
gr::digital::header_payload_demuxHeader/Payload demuxer
gr::digital::header_payload_demux_impl
hid_device_info
gr::filter::hilbert_fcHilbert transformer
gr::filter::hilbert_fc_impl
i2cAbstract class for controlling i2c bus
i2c_bbioAbstract class that implements bit banging i/o for i2c bus
i2c_bbio_ppConcrete class that bit bangs eval board i2c bus using parallel port
i2c_bitbangClass for controlling i2c bus
gr::filter::kernel::iir_filter< i_type, o_type, tap_type >Base class template for Infinite Impulse Response filter (IIR)
gr::filter::iir_filter_ffdIIR filter with float input, float output and double taps
gr::filter::iir_filter_ffd_impl
imaxdiv_t
gr::blocks::int_to_floatConvert stream of ints to a stream of floats
gr::blocks::int_to_float_impl
gr::blocks::integrate_ccIntegrate successive samples and decimate
gr::blocks::integrate_cc_impl
gr::blocks::integrate_ffIntegrate successive samples and decimate
gr::blocks::integrate_ff_impl
gr::blocks::integrate_iiIntegrate successive samples and decimate
gr::blocks::integrate_ii_impl
gr::blocks::integrate_ssIntegrate successive samples and decimate
gr::blocks::integrate_ss_impl
gr::blocks::interleaveInterleave N inputs into a single output
gr::blocks::interleave_impl
gr::blocks::interleaved_short_to_complexConvert stream of interleaved shorts to a stream of complex
gr::blocks::interleaved_short_to_complex_impl
interleaverINTERLEAVER class
interleaver_fifo< symbol_type >Template class for interleaver fifo
gr::filter::interp_fir_filter_cccInterpolating FIR filter with gr_complex input, gr_complex output and gr_complex taps
gr::filter::interp_fir_filter_ccc_impl
gr::filter::interp_fir_filter_ccfInterpolating FIR filter with gr_complex input, gr_complex output and float taps
gr::filter::interp_fir_filter_ccf_impl
gr::filter::interp_fir_filter_fccInterpolating FIR filter with float input, gr_complex output and gr_complex taps
gr::filter::interp_fir_filter_fcc_impl
gr::filter::interp_fir_filter_fffInterpolating FIR filter with float input, float output and float taps
gr::filter::interp_fir_filter_fff_impl
gr::filter::interp_fir_filter_fsfInterpolating FIR filter with float input, short output and float taps
gr::filter::interp_fir_filter_fsf_impl
gr::filter::interp_fir_filter_sccInterpolating FIR filter with short input, gr_complex output and gr_complex taps
gr::filter::interp_fir_filter_scc_impl
gr::blocks::keep_m_in_nDecimate a stream, keeping m items out of every n
gr::blocks::keep_m_in_n_impl
gr::blocks::keep_one_in_nDecimate a stream, keeping one item out of every n
gr::blocks::keep_one_in_n_impl
kiss_fft_cpx
kiss_fft_state
gr::analog::lfsrFibonacci Linear Feedback Shift Register using specified polynomial mask
gr::blocks::lfsr_15_1_0Linear Feedback Shift Register using primitive polynomial x^15 + x + 1
gr::blocks::lfsr_32kGenerate pseudo-random sequence of length 32768 bits
gr::blocks::lfsr_32k_source_sLFSR pseudo-random source with period of 2^15 bits (2^11 shorts)
gr::blocks::lfsr_32k_source_s_impl
lsp_codebook
gr::blocks::max_ffCompares vectors from multiple streams and determines the maximum value from each vector over all streams
gr::blocks::max_ff_impl
gr::blocks::max_iiCompares vectors from multiple streams and determines the maximum value from each vector over all streams
gr::blocks::max_ii_impl
gr::blocks::max_ssCompares vectors from multiple streams and determines the maximum value from each vector over all streams
gr::blocks::max_ss_impl
gr::blocks::message_burst_sourceTurn received messages into a stream and tag them for UHD to send
gr::blocks::message_burst_source_impl
gr::blocks::message_debugDebug block for the message passing system
gr::blocks::message_debug_impl
gr::blocks::message_sinkGather received items into messages and insert into msgq
gr::blocks::message_sink_impl
gr::blocks::message_sourceTurn received messages into a stream
gr::blocks::message_source_impl
gr::blocks::message_strobeSend message at defined interval
gr::blocks::message_strobe_impl
microtune_4702Class for controlling microtune 4702 tuner module
microtune_4702_eval_boardControl microtune 4702 eval board
microtune_4937Class for controlling microtune 4937 tuner module
microtune_4937_eval_boardControl microtune 4937 eval board
microtune_xxxxAbstract class for controlling microtune {4937,4702} tuner modules
microtune_xxxx_eval_boardAbstract class for controlling microtune xxxx eval board
gr::filter::mmse_fir_interpolator_ccCompute intermediate samples between signal samples x(k*Ts)
gr::filter::mmse_fir_interpolator_ffCompute intermediate samples between signal samples x(k*Ts)
MODEL
gr::blocks::moving_average_ccOutput is the moving sum of the last N samples, scaled by the scale factor
gr::blocks::moving_average_cc_impl
gr::blocks::moving_average_ffOutput is the moving sum of the last N samples, scaled by the scale factor
gr::blocks::moving_average_ff_impl
gr::blocks::moving_average_iiOutput is the moving sum of the last N samples, scaled by the scale factor
gr::blocks::moving_average_ii_impl
gr::blocks::moving_average_ssOutput is the moving sum of the last N samples, scaled by the scale factor
gr::blocks::moving_average_ss_impl
moving_averager_c
gr::filter::moving_averager_c
moving_averager_f
gr::filter::moving_averager_f
gruel::msg_accepterVirtual base class that accepts messages
gruel::msg_accepter_msgqConcrete class that accepts messages and inserts them into a message queue
gruel::msg_queueThread-safe message queue
gr::blocks::multiply_ccOutput = prod (input_0, input_1, ...)
gr::blocks::multiply_cc_impl
gr::blocks::multiply_conjugate_ccMultiplies stream 0 by the complex conjugate of stream 1
gr::blocks::multiply_conjugate_cc_impl
gr::blocks::multiply_const_ccOutput = input * complex constant
gr::blocks::multiply_const_cc_impl
gr::blocks::multiply_const_ffOutput = input * real constant
gr::blocks::multiply_const_ff_impl
gr::blocks::multiply_const_iiOutput = input * constant
gr::blocks::multiply_const_ii_impl
gr::blocks::multiply_const_ssOutput = input * constant
gr::blocks::multiply_const_ss_impl
gr::blocks::multiply_const_vccOutput = input * constant vector (element-wise)
gr::blocks::multiply_const_vcc_impl
gr::blocks::multiply_const_vffOutput = input * constant vector (element-wise)
gr::blocks::multiply_const_vff_impl
gr::blocks::multiply_const_viiOutput = input * constant vector (element-wise)
gr::blocks::multiply_const_vii_impl
gr::blocks::multiply_const_vssOutput = input * constant vector (element-wise)
gr::blocks::multiply_const_vss_impl
gr::blocks::multiply_ffOutput = prod (input_0, input_1, ...)
gr::blocks::multiply_ff_impl
gr::blocks::multiply_iiOutput = prod (input_0, input_1, ...)
gr::blocks::multiply_ii_impl
gr::blocks::multiply_ssOutput = prod (input_0, input_1, ...)
gr::blocks::multiply_ss_impl
gr::blocks::mute_ccOutput = input or zero if muted
gr::blocks::mute_cc_impl
gr::blocks::mute_ffOutput = input or zero if muted
gr::blocks::mute_ff_impl
gr::blocks::mute_iiOutput = input or zero if muted
gr::blocks::mute_ii_impl
gr::blocks::mute_ssOutput = input or zero if muted
gr::blocks::mute_ss_impl
gr::blocks::nlog10_ffOutput = n*log10(input) + k
gr::blocks::nlog10_ff_impl
noaa_hrpt_decoderNOAA HRPT Decoder
noaa_hrpt_deframerNOAA HRPT Deframer
noaa_hrpt_pll_cf
gr::analog::noise_source_cRandom number source
gr::analog::noise_source_c_impl
gr::analog::noise_source_fRandom number source
gr::analog::noise_source_f_impl
gr::analog::noise_source_iRandom number source
gr::analog::noise_source_i_impl
gr::analog::noise_source_sRandom number source
gr::analog::noise_source_s_impl
gr::blocks::nopDoes nothing. Used for testing only
gr::blocks::nop_impl
gr::blocks::not_bbOutput = ~inputbitwise boolean not of input streams
gr::blocks::not_bb_impl
gr::blocks::not_iiOutput = ~inputbitwise boolean not of input streams
gr::blocks::not_ii_impl
gr::blocks::not_ssOutput = ~inputbitwise boolean not of input streams
gr::blocks::not_ss_impl
gr::blocks::null_sinkBit bucket. Use as a termination point when a sink is required and we don't want to do anything real
gr::blocks::null_sink_impl
gr::blocks::null_sourceA source of zeros used mainly for testing
gr::blocks::null_source_impl
gr::digital::ofdm_frame_equalizer_vcvcOFDM frame equalizerThis does two things: First, it removes the coarse carrier offset. If a tag is found on the first item with the key 'ofdm_sync_carr_offset', this is interpreted as the coarse frequency offset in number of carriers. Next, it performs equalization in one or two dimensions on a tagged OFDM frame. The actual equalization is done by a ofdm_frame_equalizer object, outside of the block
gr::digital::ofdm_frame_equalizer_vcvc_impl
gr::digital::ofdm_serializer_vccSerializes complex modulations symbols from OFDM sub-carriersThis is the inverse block to the carrier_allocator_cvc. It outputs the complex data symbols as a tagged stream, discarding the pilot symbols
gr::digital::ofdm_serializer_vcc_impl
option
gr::blocks::or_bbOutput = input_0 | input_1 | , ... | input_N)Bitwise boolean or across all input streams
gr::blocks::or_bb_impl
gr::blocks::or_iiOutput = input_0 | input_1 | , ... | input_N)Bitwise boolean or across all input streams
gr::blocks::or_ii_impl
gr::blocks::or_ssOutput = input_0 | input_1 | , ... | input_N)Bitwise boolean or across all input streams
gr::blocks::or_ss_impl
gr::blocks::pack_k_bits_bbConverts a stream of bytes with 1 bit in the LSB to a byte with k relevent bits
gr::blocks::pack_k_bits_bb_impl
gr::blocks::packed_to_unpacked_bbConvert a stream of packed bytes or shorts to stream of unpacked bytes or shorts
gr::blocks::packed_to_unpacked_bb_impl
gr::blocks::packed_to_unpacked_iiConvert a stream of packed bytes or shorts to stream of unpacked bytes or shorts
gr::blocks::packed_to_unpacked_ii_impl
gr::blocks::packed_to_unpacked_ssConvert a stream of packed bytes or shorts to stream of unpacked bytes or shorts
gr::blocks::packed_to_unpacked_ss_impl
gr::digital::packet_header_defaultDefault header formatter for digital packet transmission
gr::digital::packet_header_ofdmHeader utility for OFDM signals
gr::digital::packet_headergenerator_bbGenerates a header for a tagged, streamed packet
gr::digital::packet_headergenerator_bb_impl
gr::digital::packet_headerparser_bPost header metadata as a PMT
gr::digital::packet_headerparser_b_impl
pager_flex_deinterleaveFlex deinterleave description
pager_flex_frameFlex_frame
pager_flex_parseFlex parse description
pager_flex_syncFlex sync description
pager_slicer_fbSlicer description
gr::blocks::patterned_interleaverInterleave items based on the provided vector pattern
gr::blocks::patterned_interleaver_impl
gr::blocks::pdu_to_tagged_streamTurns received PDUs into a tagged stream of items
gr::blocks::pdu_to_tagged_stream_impl
gr::blocks::peak_detector2_fbDetect the peak of a signal
gr::blocks::peak_detector2_fb_impl
gr::blocks::peak_detector_fbDetect the peak of a signal
gr::blocks::peak_detector_fb_impl
gr::blocks::peak_detector_ibDetect the peak of a signal
gr::blocks::peak_detector_ib_impl
gr::blocks::peak_detector_sbDetect the peak of a signal
gr::blocks::peak_detector_sb_impl
gr::filter::pfb_arb_resampler_ccfPolyphase filterbank arbitrary resampler with gr_complex input, gr_complex output and float taps
gr::filter::pfb_arb_resampler_ccf_impl
gr::filter::pfb_arb_resampler_fffPolyphase filterbank arbitrary resampler with float input, float output and float taps
gr::filter::pfb_arb_resampler_fff_impl
gr::filter::pfb_channelizer_ccfPolyphase filterbank channelizer with gr_complex input, gr_complex output and float taps
gr::filter::pfb_channelizer_ccf_impl
gr::filter::pfb_decimator_ccfPolyphase filterbank bandpass decimator with gr_complex input, gr_complex output and float taps
gr::filter::pfb_decimator_ccf_impl
gr::filter::pfb_interpolator_ccfPolyphase filterbank interpolator with gr_complex input, gr_complex output and float taps
gr::filter::pfb_interpolator_ccf_impl
gr::filter::pfb_synthesizer_ccfPolyphase synthesis filterbank with gr_complex input, gr_complex output and float taps
gr::filter::pfb_synthesizer_ccf_impl
gr::analog::phase_modulator_fcPhase modulator block
gr::analog::phase_modulator_fc_impl
gr::fft::plannerExport reference to planner mutex for those apps that want to use FFTW w/o using the fft_impl_fftw* classes
gr::analog::plateau_detector_fbDetects a plateau and marks the middle
gr::blocks::plateau_detector_fbDetects a plateau and marks the middle
gr::blocks::plateau_detector_fb_impl
gr::analog::plateau_detector_fb_impl
plinfoPipeline info that flows with data
gr::analog::pll_carriertracking_ccImplements a PLL which locks to the input frequency and outputs the input signal mixed with that carrier
gr::analog::pll_carriertracking_cc_impl
gr::analog::pll_freqdet_cfImplements a PLL which locks to the input frequency and outputs an estimate of that frequency. Useful for FM Demod
gr::analog::pll_freqdet_cf_impl
gr::analog::pll_refout_ccImplements a PLL which locks to the input frequency and outputs a carrier
gr::analog::pll_refout_cc_impl
pmt::pmt_any
pmt::pmt_base
pmt::pmt_bool
pmt_c32vector
pmt::pmt_c32vector
pmt_c64vector
pmt::pmt_c64vector
pmt::pmt_comperatorProvide a comparator function object to allow pmt use in stl types
pmt::pmt_complex
pmt::pmt_exception
pmt_f32vector
pmt::pmt_f32vector
pmt_f64vector
pmt::pmt_f64vector
pmt::pmt_integer
pmt::pmt_notimplemented
pmt::pmt_null
pmt::pmt_out_of_range
pmt::pmt_pair
pmt::pmt_poolVery simple thread-safe fixed-size allocation pool
pmt::pmt_real
pmt_s16vector
pmt::pmt_s16vector
pmt_s32vector
pmt::pmt_s32vector
pmt_s64vector
pmt::pmt_s64vector
pmt_s8vector
pmt::pmt_s8vector
pmt::pmt_symbol
pmt::pmt_tuple
pmt::pmt_u16vector
pmt_u16vector
pmt_u32vector
pmt::pmt_u32vector
pmt::pmt_u64vector
pmt_u64vector
pmt_u8vector
pmt::pmt_u8vector
pmt::pmt_uint64
pmt::pmt_uniform_vector
pmt::pmt_vector
pmt::pmt_wrong_type
gr::filter::kernel::polyphase_filterbankPolyphase filterbank parent class
ppioAbstract class that provides low level access to parallel port bits
ppio_ppdevAccess to parallel port bits using the linux ppdev interface
gr::analog::probe_avg_mag_sqrd_cCompute avg magnitude squared
gr::analog::probe_avg_mag_sqrd_c_impl
gr::analog::probe_avg_mag_sqrd_cfCompute avg magnitude squared
gr::analog::probe_avg_mag_sqrd_cf_impl
gr::analog::probe_avg_mag_sqrd_fCompute avg magnitude squared
gr::analog::probe_avg_mag_sqrd_f_impl
gr::blocks::probe_rateThroughput measurement
gr::blocks::probe_rate_impl
gr::blocks::probe_signal_bSink that allows a sample to be grabbed from Python
gr::blocks::probe_signal_b_impl
gr::blocks::probe_signal_cSink that allows a sample to be grabbed from Python
gr::blocks::probe_signal_c_impl
gr::blocks::probe_signal_fSink that allows a sample to be grabbed from Python
gr::blocks::probe_signal_f_impl
gr::blocks::probe_signal_iSink that allows a sample to be grabbed from Python
gr::blocks::probe_signal_i_impl
gr::blocks::probe_signal_sSink that allows a sample to be grabbed from Python
gr::blocks::probe_signal_s_impl
gr::blocks::probe_signal_vbSink that allows a vector of samples to be grabbed from Python
gr::blocks::probe_signal_vb_impl
gr::blocks::probe_signal_vcSink that allows a vector of samples to be grabbed from Python
gr::blocks::probe_signal_vc_impl
gr::blocks::probe_signal_vfSink that allows a vector of samples to be grabbed from Python
gr::blocks::probe_signal_vf_impl
gr::blocks::probe_signal_viSink that allows a vector of samples to be grabbed from Python
gr::blocks::probe_signal_vi_impl
gr::blocks::probe_signal_vsSink that allows a vector of samples to be grabbed from Python
gr::blocks::probe_signal_vs_impl
gr::analog::pwr_squelch_ccGate or zero output when input power below threshold
gr::analog::pwr_squelch_cc_impl
gr::analog::pwr_squelch_ffGate or zero output when input power below threshold
gr::analog::pwr_squelch_ff_impl
qtgui_sink_cA graphical sink to display freq, spec, time, and const plots
qtgui_sink_fA graphical sink to display freq, spec, and time
qtgui_time_sink_cA graphical sink to display multiple signals in time
qtgui_time_sink_fA graphical sink to display multiple signals in time
sssr::quad_filterQuad filter (used to compute timing error)
gr::analog::quadrature_demod_cfQuadrature demodulator: complex in, float out
gr::analog::quadrature_demod_cf_impl
QwtDblClickPlotPicker
QwtPickerDblClickPointMachine
gr::analog::rail_ffClips input values to min, max
gr::analog::rail_ff_impl
gr::filter::rational_resampler_base_cccRational Resampling Polyphase FIR filter with gr_complex input, gr_complex output and gr_complex taps
gr::filter::rational_resampler_base_ccc_impl
gr::filter::rational_resampler_base_ccfRational Resampling Polyphase FIR filter with gr_complex input, gr_complex output and float taps
gr::filter::rational_resampler_base_ccf_impl
gr::filter::rational_resampler_base_fccRational Resampling Polyphase FIR filter with float input, gr_complex output and gr_complex taps
gr::filter::rational_resampler_base_fcc_impl
gr::filter::rational_resampler_base_fffRational Resampling Polyphase FIR filter with float input, float output and float taps
gr::filter::rational_resampler_base_fff_impl
gr::filter::rational_resampler_base_fsfRational Resampling Polyphase FIR filter with float input, short output and float taps
gr::filter::rational_resampler_base_fsf_impl
gr::filter::rational_resampler_base_sccRational Resampling Polyphase FIR filter with short input, gr_complex output and gr_complex taps
gr::filter::rational_resampler_base_scc_impl
gr::blocks::regenerate_bbDetect the peak of a signal and repeat every period samples
gr::blocks::regenerate_bb_impl
gr::blocks::repack_bits_bbPack k bits from the input stream onto l bits of the output stream
gr::blocks::repack_bits_bb_impl
gr::blocks::repeatRepeat each input repeat times
gr::blocks::repeat_impl
gr::blocks::rms_cfRMS average power
gr::blocks::rms_cf_implRMS average power
gr::blocks::rms_ffRMS average power
gr::blocks::rms_ff_implRMS average power
gr::blocks::rotator
gr::analog::rotator
rs
gruel::rt_sched_param
gr::blocks::sample_and_hold_bbSample and hold circuit
gr::blocks::sample_and_hold_bb_impl
gr::blocks::sample_and_hold_ffSample and hold circuit
gr::blocks::sample_and_hold_ff_impl
gr::blocks::sample_and_hold_iiSample and hold circuit
gr::blocks::sample_and_hold_ii_impl
gr::blocks::sample_and_hold_ssSample and hold circuit
gr::blocks::sample_and_hold_ss_impl
sdr_1000_baseVery low level interface to SDR 1000 xcvr hardware
sssr::seg_sync_integratorSegment sync integrator
boost::shared_ptr< T >Shared_ptr documentation stub
shd_smini_sink
shd_smini_source
gr::blocks::short_to_charConvert stream of shorts to a stream of chars
gr::blocks::short_to_char_impl
gr::blocks::short_to_floatConvert stream of shorts to a stream of floats
gr::blocks::short_to_float_impl
gr::analog::sig_source_cSignal generator with gr_complex output
gr::analog::sig_source_c_impl
gr::analog::sig_source_fSignal generator with float output
gr::analog::sig_source_f_impl
gr::analog::sig_source_iSignal generator with int output
gr::analog::sig_source_i_impl
gr::analog::sig_source_sSignal generator with short output
gr::analog::sig_source_s_impl
gr::analog::simple_squelch_ccSimple squelch block based on average signal power and threshold in dB
gr::analog::simple_squelch_cc_impl
gr::filter::single_pole_iir< o_type, i_type, tap_type >Class template for single pole IIR filter
gr::filter::single_pole_iir< gr_complex, i_type, double >
gr::filter::single_pole_iir_filter_ccSingle pole IIR filter with complex input, complex output
gr::filter::single_pole_iir_filter_cc_impl
gr::filter::single_pole_iir_filter_ffSingle pole IIR filter with float input, float output
gr::filter::single_pole_iir_filter_ff_impl
gr::blocks::skipheadSkips the first N items, from then on copies items to the output
gr::blocks::skiphead_impl
gr::blocks::socket_pduCreates socket interface and translates traffic to PDUs
gr::blocks::socket_pdu_impl
Ui::SpectrumDisplayForm
gnuradio::detail::sptr_magic
gr::analog::squelch_base_ccBasic squelch block; to be subclassed for other squelches
gr::analog::squelch_base_cc_impl
gr::analog::squelch_base_ffBasic squelch block; to be subclassed for other squelches
gr::analog::squelch_base_ff_impl
uhd::stream_args_t
gr::blocks::stream_muxStream muxing block to multiplex many streams into one with a specified format
gr::blocks::stream_mux_impl
gr::blocks::stream_pdu_base
gr::blocks::stream_to_streamsConvert a stream of items into a N streams of items
gr::blocks::stream_to_streams_impl
gr::blocks::stream_to_vectorConvert a stream of items into a stream of blocks containing nitems_per_block
gr::blocks::stream_to_vector_impl
gr::blocks::streams_to_streamConvert N streams of 1 item into a 1 stream of N items
gr::blocks::streams_to_stream_impl
gr::blocks::streams_to_vectorConvert N streams of items to 1 stream of vector length N
gr::blocks::streams_to_vector_impl
gr::blocks::stretch_ffAdjust y-range of an input vector by mapping to range (max-of-input, stipulated-min). Primarily for spectral signature matching by normalizing spectrum dynamic ranges
gr::blocks::stretch_ff_impl
gr::blocks::sub_ccOutput = input_0 - input_1 - ...)
gr::blocks::sub_cc_impl
gr::blocks::sub_ffOutput = input_0 - input_1 - ...)
gr::blocks::sub_ff_impl
gr::blocks::sub_iiOutput = input_0 - input_1 - ...)
gr::blocks::sub_ii_impl
gr::blocks::sub_ssOutput = input_0 - input_1 - ...)
gr::blocks::sub_ss_impl
atsc::syminfo
gruel::sys_pri
gr::blocks::tag_debugBit bucket that prints out any tag received
gr::blocks::tag_debug_impl
gr::blocks::tag_gateControl tag propagation.Use this block to stop tags from propagating
gr::blocks::tag_gate_impl
tag_sink_demo
tag_source_demo
gr::blocks::tagged_file_sinkA file sink that uses tags to save files
gr::blocks::tagged_file_sink_impl
gr::blocks::tagged_stream_muxCombines tagged streams
gr::blocks::tagged_stream_mux_impl
gr::blocks::tagged_stream_to_pduTurns received stream data and tags into PDUs
gr::blocks::tagged_stream_to_pdu_impl
gr::blocks::tcp_connection
tcp_connection
gruel::thread_body_wrapper< F >
gruel::thread_group
gr::blocks::threshold_ffOutput a 1 or zero based on a threshold value
gr::blocks::threshold_ff_impl
gr::blocks::throttleThrottle flow of samples such that the average rate does not exceed samples_per_sec
gr::blocks::throttle_impl
gr::blocks::transcendentalA block that performs various transcendental math operations
gr::blocks::transcendental_impl
trellis_constellation_metrics_cfEvaluate metrics for use by the Viterbi algorithm
trellis_encoder_bbConvolutional encoder
trellis_encoder_biConvolutional encoder
trellis_encoder_bsConvolutional encoder
trellis_encoder_iiConvolutional encoder
trellis_encoder_siConvolutional encoder
trellis_encoder_ssConvolutional encoder
trellis_metrics_cEvaluate metrics for use by the Viterbi algorithm
trellis_metrics_fEvaluate metrics for use by the Viterbi algorithm
trellis_metrics_iEvaluate metrics for use by the Viterbi algorithm
trellis_metrics_sEvaluate metrics for use by the Viterbi algorithm
trellis_pccc_decoder_b
trellis_pccc_decoder_combined_cb
trellis_pccc_decoder_combined_ci
trellis_pccc_decoder_combined_cs
trellis_pccc_decoder_combined_fb
trellis_pccc_decoder_combined_fi
trellis_pccc_decoder_combined_fs
trellis_pccc_decoder_i
trellis_pccc_decoder_s
trellis_pccc_encoder_bbSCCC encoder
trellis_pccc_encoder_biSCCC encoder
trellis_pccc_encoder_bsSCCC encoder
trellis_pccc_encoder_iiSCCC encoder
trellis_pccc_encoder_siSCCC encoder
trellis_pccc_encoder_ssSCCC encoder
trellis_permutationPermutation
trellis_sccc_decoder_b
trellis_sccc_decoder_combined_cb
trellis_sccc_decoder_combined_ci
trellis_sccc_decoder_combined_cs
trellis_sccc_decoder_combined_fb
trellis_sccc_decoder_combined_fi
trellis_sccc_decoder_combined_fs
trellis_sccc_decoder_i
trellis_sccc_decoder_s
trellis_sccc_encoder_bbSCCC encoder
trellis_sccc_encoder_biSCCC encoder
trellis_sccc_encoder_bsSCCC encoder
trellis_sccc_encoder_iiSCCC encoder
trellis_sccc_encoder_siSCCC encoder
trellis_sccc_encoder_ssSCCC encoder
trellis_siso_combined_f
trellis_siso_f
trellis_viterbi_b
trellis_viterbi_combined_cb
trellis_viterbi_combined_ci
trellis_viterbi_combined_cs
trellis_viterbi_combined_fb
trellis_viterbi_combined_fi
trellis_viterbi_combined_fs
trellis_viterbi_combined_ib
trellis_viterbi_combined_ii
trellis_viterbi_combined_is
trellis_viterbi_combined_sb
trellis_viterbi_combined_si
trellis_viterbi_combined_ss
trellis_viterbi_i
trellis_viterbi_s
gr::blocks::tuntap_pduCreates TUNTAP interface and translates traffic to PDUs
gr::blocks::tuntap_pdu_impl
gr::blocks::uchar_to_floatConvert stream of unsigned chars to a stream of floats
gr::blocks::uchar_to_float_impl
gr::blocks::udp_sinkWrite stream to an UDP socket
gr::blocks::udp_sink_impl
gr::blocks::udp_sourceRead stream from an UDP socket
gr::blocks::udp_source_impl
uhd_amsg_source
uhd_usrp_sink
uhd_usrp_source
Ui_SpectrumDisplayForm
gr::blocks::unpack_k_bits_bbConverts a byte with k relevent bits to k output bytes with 1 bit in the LSB
gr::blocks::unpack_k_bits_bb_impl
gr::blocks::unpacked_to_packed_bbConvert a stream of unpacked bytes or shorts into a stream of packed bytes or shorts
gr::blocks::unpacked_to_packed_bb_impl
gr::blocks::unpacked_to_packed_iiConvert a stream of unpacked bytes or shorts into a stream of packed bytes or shorts
gr::blocks::unpacked_to_packed_ii_impl
gr::blocks::unpacked_to_packed_ssConvert a stream of unpacked bytes or shorts into a stream of packed bytes or shorts
gr::blocks::unpacked_to_packed_ss_impl
v_float_u
gr::blocks::vco_fVCO - Voltage controlled oscillator
gr::blocks::vco_f_impl
std::vector< T >Vector documentation stub
gr::blocks::vector_insert_bSource of unsigned char's that gets its data from a vector
gr::blocks::vector_insert_b_impl
gr::blocks::vector_insert_cSource of gr_complex's that gets its data from a vector
gr::blocks::vector_insert_c_impl
gr::blocks::vector_insert_fSource of float's that gets its data from a vector
gr::blocks::vector_insert_f_impl
gr::blocks::vector_insert_iSource of int's that gets its data from a vector
gr::blocks::vector_insert_i_impl
gr::blocks::vector_insert_sSource of short's that gets its data from a vector
gr::blocks::vector_insert_s_impl
gr::blocks::vector_mapMaps elements from a set of input vectors to a set of output vectors
gr::blocks::vector_map_impl
gr::blocks::vector_sink_bUnsigned char sink that writes to a vector
gr::blocks::vector_sink_b_impl
gr::blocks::vector_sink_cGr_complex sink that writes to a vector
gr::blocks::vector_sink_c_impl
gr::blocks::vector_sink_fFloat sink that writes to a vector
gr::blocks::vector_sink_f_impl
gr::blocks::vector_sink_iInt sink that writes to a vector
gr::blocks::vector_sink_i_impl
gr::blocks::vector_sink_sShort sink that writes to a vector
gr::blocks::vector_sink_s_impl
gr::blocks::vector_source_bSource of unsigned char's that gets its data from a vector
gr::blocks::vector_source_b_impl
gr::blocks::vector_source_cSource of gr_complex's that gets its data from a vector
gr::blocks::vector_source_c_impl
gr::blocks::vector_source_fSource of float's that gets its data from a vector
gr::blocks::vector_source_f_impl
gr::blocks::vector_source_iSource of int's that gets its data from a vector
gr::blocks::vector_source_i_impl
gr::blocks::vector_source_sSource of short's that gets its data from a vector
gr::blocks::vector_source_s_impl
gr::blocks::vector_to_streamConvert a stream of blocks of nitems_per_block items into a stream of items
gr::blocks::vector_to_stream_impl
gr::blocks::vector_to_streamsConvert 1 stream of vectors of length N to N streams of items
gr::blocks::vector_to_streams_impl
video_sdl_sink_sVideo sink using SDL
video_sdl_sink_ucVideo sink using SDL
viterbi_state
vocoder_alaw_decode_bsThis block performs alaw audio decoding
vocoder_alaw_encode_sbThis block performs g.711 alaw audio encoding
vocoder_codec2_decode_psCODEC2 Vocoder Decoder
vocoder_codec2_encode_spCODEC2 Vocoder Encoder
vocoder_cvsd_decode_bsThis block performs CVSD audio decoding. Its design and implementation is modeled after the CVSD encoder/decoder specifications defined in the Bluetooth standard
vocoder_cvsd_encode_sbThis block performs CVSD audio encoding. Its design and implementation is modeled after the CVSD encoder/decoder specifications defined in the Bluetooth standard
vocoder_g721_decode_bsThis block performs g721 audio decoding
vocoder_g721_encode_sbThis block performs g721 audio encoding
vocoder_g723_24_decode_bsThis block performs g723_24 audio decoding
vocoder_g723_24_encode_sbThis block performs g723_24 audio encoding
vocoder_g723_40_decode_bsThis block performs g723_40 audio decoding
vocoder_g723_40_encode_sbThis block performs g723_40 audio encoding
vocoder_gsm_fr_decode_psGSM 06.10 Full Rate Vocoder Decoder
vocoder_gsm_fr_encode_spGSM 06.10 Full Rate Vocoder Encodershorts in; 33 byte packets out
vocoder_ulaw_decode_bsThis block performs ulaw audio decoding
vocoder_ulaw_encode_sbThis block performs g.711 ulaw audio encoding
volk_arch_pref
VOLK_CPU
volk_func_desc
volk_machine
wavelet_squash_ff
wavelet_squash_ff_impl
wavelet_wavelet_ffCompute wavelet transform using gsl routines
wavelet_wavelet_ff_impl
wavelet_wvps_ffComputes the Wavelet Power Spectrum from a set of wavelet coefficients
wavelet_wvps_ff_impl
gr::blocks::wavfile_sinkWrite stream to a Microsoft PCM (.wav) file
gr::blocks::wavfile_sink_impl
gr::blocks::wavfile_sourceRead stream from a Microsoft PCM (.wav) file, output floats
gr::blocks::wavfile_source_impl
xmm_register
xmm_regs
gr::blocks::xor_bbOutput = input_0 ^ input_1 ^ , ... ^ input_N)Bitwise boolean xor across all input streams
gr::blocks::xor_bb_impl
gr::blocks::xor_iiOutput = input_0 ^ input_1 ^ , ... ^ input_N)Bitwise boolean xor across all input streams
gr::blocks::xor_ii_impl
gr::blocks::xor_ssOutput = input_0 ^ input_1 ^ , ... ^ input_N)Bitwise boolean xor across all input streams
gr::blocks::xor_ss_impl