本文简要介绍 python 语言中 scipy.signal.max_len_seq
的用法。
用法:
scipy.signal.max_len_seq(nbits, state=None, length=None, taps=None)#
最大长度序列 (MLS) 生成器。
- nbits: int
要使用的位数。结果序列的长度将为
(2**nbits) - 1
。请注意,生成长序列(例如,大于nbits == 16
)可能需要很长时间。- state: 数组,可选
如果是数组,则长度必须为
nbits
,并且将被强制转换为二进制(布尔)表示。如果没有,将使用一个种子,产生一个可重复的表示。如果state
全为零,则会引发错误,因为这是无效的。默认值:无。- length: 整数,可选
要计算的样本数。如果没有,则计算整个长度
(2**nbits) - 1
。- taps: 数组,可选
要使用的多项式抽头(例如,
[7, 6, 1]
用于 8 位序列)。如果没有,将自动选择水龙头(最多为nbits == 32
)。
- seq: 数组
生成 0 和 1 的 MLS 序列。
- state: 数组
移位寄存器的最终状态。
参数 ::
返回 ::
注意:
MLS 生成算法一般说明于:
抽头的默认值具体取自为
nbits
的每个值列出的第一个选项:例子:
MLS 使用二进制约定:
>>> from scipy.signal import max_len_seq >>> max_len_seq(4)[0] array([1, 1, 1, 1, 0, 1, 0, 1, 1, 0, 0, 1, 0, 0, 0], dtype=int8)
MLS 具有白频谱(DC 除外):
>>> import numpy as np >>> import matplotlib.pyplot as plt >>> from numpy.fft import fft, ifft, fftshift, fftfreq >>> seq = max_len_seq(6)[0]*2-1 # +1 and -1 >>> spec = fft(seq) >>> N = len(seq) >>> plt.plot(fftshift(fftfreq(N)), fftshift(np.abs(spec)), '.-') >>> plt.margins(0.1, 0.1) >>> plt.grid(True) >>> plt.show()
MLS 的循环自相关是一个脉冲:
>>> acorrcirc = ifft(spec * np.conj(spec)).real >>> plt.figure() >>> plt.plot(np.arange(-N/2+1, N/2+1), fftshift(acorrcirc), '.-') >>> plt.margins(0.1, 0.1) >>> plt.grid(True) >>> plt.show()
MLS 的线性自相关近似是一个脉冲:
>>> acorr = np.correlate(seq, seq, 'full') >>> plt.figure() >>> plt.plot(np.arange(-N+1, N), acorr, '.-') >>> plt.margins(0.1, 0.1) >>> plt.grid(True) >>> plt.show()
相关用法
- Python SciPy signal.morlet用法及代码示例
- Python SciPy signal.minimum_phase用法及代码示例
- Python SciPy signal.medfilt2d用法及代码示例
- Python SciPy signal.morlet2用法及代码示例
- Python SciPy signal.czt_points用法及代码示例
- Python SciPy signal.chirp用法及代码示例
- Python SciPy signal.residue用法及代码示例
- Python SciPy signal.iirdesign用法及代码示例
- Python SciPy signal.kaiser_atten用法及代码示例
- Python SciPy signal.oaconvolve用法及代码示例
- Python SciPy signal.hilbert用法及代码示例
- Python SciPy signal.ricker用法及代码示例
- Python SciPy signal.group_delay用法及代码示例
- Python SciPy signal.cheb2ord用法及代码示例
- Python SciPy signal.get_window用法及代码示例
- Python SciPy signal.lfilter用法及代码示例
- Python SciPy signal.coherence用法及代码示例
- Python SciPy signal.dfreqresp用法及代码示例
- Python SciPy signal.TransferFunction用法及代码示例
- Python SciPy signal.dbode用法及代码示例
- Python SciPy signal.residuez用法及代码示例
- Python SciPy signal.bilinear_zpk用法及代码示例
- Python SciPy signal.firls用法及代码示例
- Python SciPy signal.impulse用法及代码示例
- Python SciPy signal.buttord用法及代码示例
注:本文由纯净天空筛选整理自scipy.org大神的英文原创作品 scipy.signal.max_len_seq。非经特殊声明,原始代码版权归原作者所有,本译文未经允许或授权,请勿转载或复制。