本文简要介绍 python 语言中 scipy.signal.ShortTimeFFT.spectrogram
的用法。
用法:
ShortTimeFFT.spectrogram(x, y=None, detr=None, *, p0=None, p1=None, k_offset=0, padding='zeros', axis=-1)#
计算频谱图或cross-spectrogram。
频谱图是 STFT 的绝对平方,即
abs(S[q,p])**2
对于给定的S[q,p]
因此总是非负的。对于两个 STFTSx[q,p], Sy[q,p]
,cross-spectrogram 定义为Sx[q,p] * np.conj(Sx[q,p])
是complex-valued。这是一个方便调用的函数stft
/stft_detrend
,因此所有参数都在那里讨论。如果y不是None
它需要具有相同的形状x.例子:
以下示例显示了以 20 Hz 采样的不同频率的方波频谱图 (在图中用绿色虚线标记):
>>> import matplotlib.pyplot as plt >>> import numpy as np >>> from scipy.signal import square, ShortTimeFFT >>> from scipy.signal.windows import gaussian ... >>> T_x, N = 1 / 20, 1000 # 20 Hz sampling rate for 50 s signal >>> t_x = np.arange(N) * T_x # time indexes for signal >>> f_i = 5e-3*(t_x - t_x[N // 3])**2 + 1 # varying frequency >>> x = square(2*np.pi*np.cumsum(f_i)*T_x) # the signal
使用的高斯窗口有 50 个样本或 2.5 秒长。选择参数
mfft=800
(过采样因子 16)和ShortTimeFFT
中的hop
间隔 2,以产生足够数量的点:>>> g_std = 12 # standard deviation for Gaussian window in samples >>> win = gaussian(50, std=g_std, sym=True) # symmetric Gaussian wind. >>> SFT = ShortTimeFFT(win, hop=2, fs=1/T_x, mfft=800, scale_to='psd') >>> Sx2 = SFT.spectrogram(x) # calculate absolute square of STFT
该图的颜色图按对数缩放,功率谱密度以 dB 为单位。信号 x 的时间范围由垂直虚线标记,阴影区域标记边界效应的存在:
>>> fig1, ax1 = plt.subplots(figsize=(6., 4.)) # enlarge plot a bit >>> t_lo, t_hi = SFT.extent(N)[:2] # time range of plot >>> ax1.set_title(rf"Spectrogram ({SFT.m_num*SFT.T:g}$\,s$ Gaussian " + ... rf"window, $\sigma_t={g_std*SFT.T:g}\,$s)") >>> ax1.set(xlabel=f"Time $t$ in seconds ({SFT.p_num(N)} slices, " + ... rf"$\Delta t = {SFT.delta_t:g}\,$s)", ... ylabel=f"Freq. $f$ in Hz ({SFT.f_pts} bins, " + ... rf"$\Delta f = {SFT.delta_f:g}\,$Hz)", ... xlim=(t_lo, t_hi)) >>> Sx_dB = 10 * np.log10(np.fmax(Sx2, 1e-4)) # limit range to -40 dB >>> im1 = ax1.imshow(Sx_dB, origin='lower', aspect='auto', ... extent=SFT.extent(N), cmap='magma') >>> ax1.plot(t_x, f_i, 'g--', alpha=.5, label='$f_i(t)$') >>> fig1.colorbar(im1, label='Power Spectral Density ' + ... r"$20\,\log_{10}|S_x(t, f)|$ in dB") ... >>> # Shade areas where window slices stick out to the side: >>> for t0_, t1_ in [(t_lo, SFT.lower_border_end[0] * SFT.T), ... (SFT.upper_border_begin(N)[0] * SFT.T, t_hi)]: ... ax1.axvspan(t0_, t1_, color='w', linewidth=0, alpha=.3) >>> for t_ in [0, N * SFT.T]: # mark signal borders with vertical line ... ax1.axvline(t_, color='c', linestyle='--', alpha=0.5) >>> ax1.legend() >>> fig1.tight_layout() >>> plt.show()
对数缩放揭示了方波的奇次谐波,这些谐波在 10 Hz 的奈奎斯特频率处反映出来。这种混叠也是图中噪声伪影的主要来源。
相关用法
- Python SciPy ShortTimeFFT.from_dual用法及代码示例
- Python SciPy ShortTimeFFT.from_window用法及代码示例
- Python SciPy ShortTimeFFT.istft用法及代码示例
- Python SciPy SmoothSphereBivariateSpline.ev用法及代码示例
- Python SciPy SuperLU.perm_c用法及代码示例
- Python SciPy SmoothBivariateSpline.__call__用法及代码示例
- Python SciPy SuperLU.solve用法及代码示例
- Python SciPy SuperLU.perm_r用法及代码示例
- Python SciPy SmoothBivariateSpline.ev用法及代码示例
- Python SciPy SmoothSphereBivariateSpline.__call__用法及代码示例
- Python SciPy interpolate.make_interp_spline用法及代码示例
- Python SciPy stats.anderson用法及代码示例
- Python SciPy ClusterNode.pre_order用法及代码示例
- Python SciPy stats.iqr用法及代码示例
- Python SciPy FortranFile.read_record用法及代码示例
- Python SciPy ndimage.correlate用法及代码示例
- Python SciPy special.exp1用法及代码示例
- Python SciPy special.expn用法及代码示例
- Python SciPy signal.czt_points用法及代码示例
- Python SciPy interpolate.krogh_interpolate用法及代码示例
- Python SciPy ndimage.morphological_gradient用法及代码示例
- Python SciPy distance.sokalmichener用法及代码示例
- Python SciPy linalg.eigvalsh_tridiagonal用法及代码示例
- Python SciPy linalg.cdf2rdf用法及代码示例
- Python SciPy csc_array.diagonal用法及代码示例
注:本文由纯净天空筛选整理自scipy.org大神的英文原创作品 scipy.signal.ShortTimeFFT.spectrogram。非经特殊声明,原始代码版权归原作者所有,本译文未经允许或授权,请勿转载或复制。