本文簡要介紹 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。非經特殊聲明,原始代碼版權歸原作者所有,本譯文未經允許或授權,請勿轉載或複製。