scipy.signal.
max_len_seq#
- scipy.signal.max_len_seq(nbits, state=None, length=None, taps=None)[源代码]#
最大长度序列 (MLS) 生成器。
- 参数:
- nbitsint
要使用的位数。结果序列的长度将为
(2**nbits) - 1
。请注意,生成较长序列(例如,大于nbits == 16
)可能需要很长时间。- statearray_like,可选
如果为数组,则长度必须为
nbits
,且将转换为二进制(布尔值)表示形式。如果为 None,则使用全 1 种子,生成可重复的表示形式。如果state
全为 0,则会引发错误,因为它无效。默认值:None。- lengthint,可选
要计算的样本数量。如果为 None,则会计算整个长度
(2**nbits) - 1
。- tapsarray_like,可选
要使用的多项式抽头(例如,
[7, 6, 1]
对于 8 位序列)。如果无,则将自动选择抽头(最多nbits == 32
)。
- 返回:
- seqarray
由 0 和 1 组成的所得 MLS 序列。
- statearray
移位寄存器的最终状态。
注释
用于 MLS 生成的算法在以下内容中进行了通用描述
抽头的默认值专门从以下位置获取:
nbits
的值在以下位置所列的第一个选项中取得在版本 0.15.0 中添加。
示例
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()