The spectral density format is appropriate for random or noise
signals but inappropriate for discrete frequency components because the
latter theoretically have zero bandwidth
Amplitude Correction
A finite-duration window \(w[n]\)
DTFT is \(W[e^{j\omega}]\) and the
maximum magnitude is is at DC frequency, which \(\sum_n w_n\)
Sinusoidal signal \(x[n]\)
DFS is \(X_k\), and DTFT shall be
\(\frac{2\pi}{N}X_k(e^{j\omega})\)
the windowed sequence \(v[n] =
x[n]w[n]\)
with multiplication property, DTFT of \(v[n]\) shall be \(\frac{X_k(e^{j\omega})}{N}\sum_n w_n\)
As we know, DFT of \(v[n]\) is
samples of its DTFT, that is \[
\frac{X_k(e^{j\omega})}{N}\sum_n w_n = X_v[k]
\] Therefore, \[
\frac{X_k(e^{j\omega})}{N} = \frac{X_v[k]}{\sum_n w_n}
\]
Effective Noise BandWidth
(ENBW)
General derivation
The relationship between a power spectrum (\(PS, V^2\)) and a power spectral
density (\(PSD, V^2/Hz\)) is given
by the effective noise bandwidth (ENBW), which
can easily be determined at the time when the DFT is computed.
ENBW should always be recorded when a spectrum or spectral density is
computed, such that the result can be converted to the other form at a
later stage, when the information about the frequency resolution \(f_{res}\) and the window that was used is
normally not easily available any more.
The normalized equivalent noise bandwidth (NENBW) of
the window is given by
\[
\text{NENBW} = \frac{NS_2}{S_1^2}
\] where \(S_1 = \sum
_{k=0}^{N-1}w_k\) and \(S_2 = \sum
_{k=0}^{N-1}w_k^2\)
Equivalent noise bandwidth (ENBW) compares a window to an
ideal, rectangular time-window. It is the bandwidth of the
rectangular window's frequency-domain shape that passes the same
amount of white noise energy as the frequency-domain
shape defined by the other window.
Therefore, the equivalent noise bandwidth \(B_{enbw}\) is given by
Assuming the windowed sequence \(v[n] =
x[n]w[n]\)
\(W[k]\): Fourier Transform of
finite sequence window
\(X_{sig}\): Fourier Transform
of signal
\(X_{n}\): Fourier Transform of
noise
\(X_{v,sig}\): Fourier Transform
of windowed signal
\(X_{v,n}\): Fourier Transform
of windowed noise
From Fig. 6,, we observe that the amplitude of the harmonic estimate
at a given frequency is biased by the accumulated broad-band noise
included in the bandwidth of the window.
In this sense, the window behaves as a filter, gathering
contributions for its estimate over its bandwidth
The Fourier Transform of windowed signal can be expressed as
DFT bin's output noise standard deviation (rms)
value is proportional to \(\sqrt{N}\),
and the DFT's output magnitude for the bin containing the signal
tone is proportional to \(N\)
signal tone power \[
P_{\text{sig}} = 2 \frac{X_{w,sig}^2}{N^2}
\]
noise power \[
P_n = \frac{X_{w,n}^2}{N}
\]
The displayed SNR\[
\mathrm{SNR} = \mathrm{SNR}' - 10\log_{10}(2/N)
\] If we increase a DFT's size from \(N\) to \(2N\), the DFT's output SNR increased by
3dB. So we say that a DFT's processing gain increases
by 3dB whenever \(N\) is doubled.
1 2 3 4 5 6
for N=[2^62^82^102^12] wd = rectwin(N); nbw = enbw(wd)/N; snr_shift = 10*log10(nbw * 2); disp(snr_shift); end
output:
1 2 3 4 5 6 7
-15.0515
-21.0721
-27.0927
-33.1133
How spectrum analyzer work?
We tried to plot a power spectral density together with
something that we want to interpret as a power spectrum
spectrum of a periodic signal
spectral density of a broadband signal such as noise
Sine-wave components are located in individual FFT bins, but
broadband signals like noise have their power spread over all FFT
bins!
The problem with sine-wave scaling is that the noise power is, on
average, evenly distributed over all FFT bins, whereas the
sine-wave power is concentrated in only a few bins. With
sine-wave scaling, the power of individual sine-wave components can be
read directly from the spectral plot, but in order to determine the
noise power, the powers of all the noise bins must be added
together.
%Clear variables. clear command window, close all figures: clc; clear all; close all; %%%Setup and define variables f0=10; %frequency of sinusoidal signal (Hz) fs=100; %sampling frequency (Hz) Ts=1/fs; %sampling period (seconds) N0=3000; %number of samples t=[0:Ts:Ts*(N0-1)]; %Sample times noise_PSD=.5; %This is the desired noise power spectral density in W/Hz. variance=noise_PSD*fs;% Variance = sigma^2 sigma=sqrt(variance); noise=transpose(sigma*randn(N0,1));%create sampled white Gaussian noise. xsignal=20*sin(2*pi*f0*t); %create sampled sinusoidal signal x=xsignal+noise; %Add signal to noise figure(1) histogram(noise,30) %plot histogram set(gca,'FontSize',14) %set font size of axis tick labels to 18 xlabel('Noise amplitude','fontsize',14) ylabel('Frequency of occurance','fontsize',14) title('Simulated histogram of white Gaussian noise','fontsize',14) SNR_try1=snr(xsignal,noise); %calculate SNR using built in "snr" function. SNR_try2=10*log10(sum(xsignal.^2)/sum(noise.^2)); %manually calculate SNR. %If everything is correct, the two SNR calculations above should agree. %Plot noise in time-domain figure(2) plot(t,x) set(gca,'FontSize',14) %set font size of axis tick labels to 18 xlabel('Time (s)','fontsize',14) ylabel('Amplitude','fontsize',14) title('Noisey sinusoid','fontsize',14) grid on %Plot power spectral density (PSD) of noise using three different methods: % %Method 1. Calcululate PSD from amplitude spectrum N=2^16; %Number of discrete points in the FFT y=fft(x,N)/fs; %fft of noise z=fftshift(y);%center noise spectrum f_vec=[0:1:N-1]*fs/N-fs/2; %designate sample frequencies amplitude_spectrum=abs(z); %compute two-sided amplitude spectrum ESD1=amplitude_spectrum.^2; %ESD = |F(w)|^2; PSD1=ESD1/((N0-1)*Ts);% PSD=ESD/T where T = total time of sample figure(3) plot(f_vec,10*log10(PSD1)); xlabel('Frequency [Hz]','fontsize',14) ylabel('dB/Hz','fontsize',14) title('Power spectral density - method 1','fontsize',14) grid on set(gcf,'color','w'); %set background color from grey (default) to white axis tight %calculate average power using PSD calclated from method 1: Average_power_method_1=sum(PSD1)*fs/N; % Pav=sum(PSD)*delta_f where delta_f=fs/N; % %Method 2 - Calculate PSD from autocorrelation time_lag=((-length(x)+1):1:(length(x)-1))*Ts; auto_cor=xcorr(x,x)/fs; %Use xcorr function to find PSD y=1/fs*fft(auto_cor,N); %fft of auto correlation function PSD2=abs(1/(N0-1)*fftshift(fft(auto_cor,N))); figure(4) plot(f_vec,10*log10(PSD2));%use convolution xlabel('Frequency [Hz]','fontsize',14) ylabel('dB/Hz','fontsize',14) title('Power spectral density - method 2','fontsize',14) grid on set(gcf,'color','w'); %set background color from grey (default) to white axis tight %calculate average power using PSD calclated from method 1: Average_power_method_2=sum(PSD2)*fs/N; %Pav=sum(PSD)*delta_f where delta_f=fs/N; % %Method 3 - Calculate PSD using built in pwelch function figure(5) PSD3=periodogram(x,[],N,fs,'centered'); plot(10*log10(PSD3)) xlabel('Frequency [Hz]','fontsize',14) ylabel('dB/Hz','fontsize',14) title('Power spectral density - method 3','fontsize',14) grid on set(gcf,'color','w'); %set background color from grey (default) to white axis tight Average_power_method_3=sum(PSD3)*fs/N; %Pav=sum(PSD)*delta_f where delta_f=fs/N; % %Calculate mean and average PSD of noise: PSD_noise=periodogram(noise,[],N,fs,'centered'); Average_noise_PSD=mean(PSD_noise); Mean_noise=mean(noise);
The power spectral density plots for methods 2 and 3 exactly match
that for method 1 (shown above).
A finite-length data record = an infinite record multiplied by a
rectangular window
Windowing is unavoidable
Applying the Hanning window (or any window) to a periodic
signal creates leakage.
leakage:
The component at one frequency leaks into the vicinity of another
compnent owing to the spectral smearing introdued by
window.
Notice side lobes adding out of phase can reduce
the heights of the peaks
Windowed Signal
Short transient signals in the time domain produce high, broadband
frequency content.
To reduce leakage, a mathematical function called a
window is applied to the data. Windows are designed to
reduce the sharp transient in the re-created signal as much as
possible.
Because the sharp transients are reduced and smoothed, the broadband
frequency of the spectral leakage is also reduced.
Periodic versus
Non-Periodic Background
When performing a Fourier Transform on measurement data, a window
affects periodic and non-periodic data differently:
Periodic (No Window needed): A signal captured
in a periodic manner does not require a window, and a resulting Fourier
Transform has no leakage. Applying a window alters the resulting Fourier
transform, and even creates spectral leakage where there would have been
no leakage otherwise.
Non-periodic (Window needed): Windows are used
on signals that are captured in a non-periodic manner to reduce spectral
leakage and get closer to the periodic results. A window can minimize
the leakage present in a non-periodic signal, but cannot eliminate
it.
The signal is repeated and appended mathematically because the
measured data is assumed to be representative of the entire original
signal
Periodic
When a measurement signal is captured in a periodic manner, the
Fourier Transform of the captured signal will have no
leakage in the frequency domain.
A window is not recommended for a periodic signal as it will distort
the signal in an unnecessary manner, and actually creates spectral
leakage.
Non-periodic
The same sine wave, with a different measurement time, results in a
non-periodic captured signal. Here, when the captured signal is
repeated, the original sine wave signal is not re-created.
In fact, several broadband transient events (circled in red) are
introduced. These transients create a broadband response, or
leakage.
Windows are used to minimize this leakage effect in
the frequency domain.
Hanning
When doing operational noise and vibration measurements, the Hanning
window is commonly used.
Random data has spectral leakage due to the abrupt cutoff at
the beginning and end of the time block. It is
non-periodic.
There is no way to ensure that the captured random
signal is periodic by varying the measurement time.
Hanning windows are often used with random data
because they have moderate impact on the frequency resolution and
amplitude accuracy of the resulting frequency spectrum.
The maximum amplitude error of a Hanning window is
15%
In the cited article, all spectral data had an amplitude
correction factor applied.
while the frequency leakage is typically confined to 1.5
spectral lines to each side of the original sine wave
signal
periodic signal
Applying the Hanning window (or any window) to a periodic signal
creates leakage.
The periodically captured sine wave with the Hanning window
(blue) is wider in frequency than the original signal (red)
In the figure, the sine wave with the Hanning window (blue) is
wider in frequency than the original signal (red).
non-periodic signal
When a Hanning window is applied to a non-periodic signal, the
leakage is greatly reduced and the amplitude is higher.
A non-periodically captured sine wave (magenta) has a
spectral leakage over the entire bandwidth, applying a Hanning window
minimized the leakage (green)
RMS calculation
A RMS calculationsums up the energy within a
frequency range.
both the RMS of the periodic and non-periodic signals with a
Hanning window are equal to the RMS of the leakage-free sine
wave.
Only the RMS of the non-periodic sine wave without a window
applied is not equal to the others
With the leakage spread over a smaller frequency range, doing
analysis calculations like RMS yields more accurate
results.
Flattop
The Flattop window has a better amplitude accuracy in
frequency domain compared to the Hanning window,
The maximum amplitude error of a Flattop window is less than
0.01%. By contrast, the Hanning window maximum amplitude error is
15%.
A Flattop window confines leakage to 3.43 spectral lines
to each side of the original signal.
amplitude errors
These maximum amplitude errors assume that amplitude correction
factors are applied to the frequency spectrums. These amplitude
correction factors compensate for any reduction caused by applying a
window.
leakage
The frequency accuracy of the Flattop window is more coarse compared
to a Hanning window. As a result, the Flattop window is typically
employed on data where frequency peaks are distinct and well separated
from each other.
When the frequency peaks are not guaranteed to be well separated, the
Hanning window is preferred because it is less likely to cause
individual peaks to be lost in the spectrum
Spectrum of two periodically captured tones that are \(4Hz\) apart with a \(1Hz\) frequency resolution. The spectrum
with a Hanning window (green) shows two peaks while the spectrum with a
Flattop window (blue) shows one peak.
Note that at the original frequencies of the tones the amplitude is
correct and equal to one for both windows.
One common application for a flattop window is performing
calibration. For example, a sound pistonphone only produces
one single and distinct frequency during microphone
calibration.
Uniform
A Uniform window has a value of 1.0 across the entire
measurement time. In reality, a Uniform window could be
called no window.
Depending on the data acquisition system used, sometimes the term
Rectangular window is also used.
A Uniform window creates no frequency or amplitude distortion
when the measured signal is periodic.
When a measured signal is not periodic, the amplitude is reduced
by a maximum of 36% and the frequency content is spread over
the entire bandwidth of the measurement.
This is due to sharp transients that are created by
repeating and appending the measured signal.
Whenever a measurement signal is periodic, a Uniform window is
preferred.
Applying a Hanning or Flattop window to a periodic signal will
actually create amplitude and frequency distortion.
Benefit of Reducing Leakage
The benefit is not that the captured signal is
perfectly replicated.
The main benefit is that the leakage is now confined over a
smaller frequency range, instead of affecting the entire
frequency bandwidth of the measurement.
With the leakage spread over a smaller frequency range, doing
analysis calculations like RMS yields more accurate results.
It is impossible to calculate the proper RMS amplitude estimate over
a limited frequency range of the un-windowed sine wave, since
the leakage is over the full frequency range. Therefore the RMS
amplitude is not correct.
Two tones
In the case of two closely spaced sine tones, without a window being
applied, two tones frequencies would leak into each other, which make
determining the true amplitude of individual peaks very difficult.
The window makes it easier to separate and distinguish each tone so a
proper analysis could be performed.
window function in
frequency domain
The transfer function \(a(f)\) of a
window \(w_j, j \in [0, N-1]\)
expresses the response of the window to a sinusoidal signal at an offset
of \(f\) frequency bins, i.e. DFT .
real part:\[
a_r(f)=\sum_{j=0}^{N-1}w_j\cos (2\pi f j/N)
\]
imaginary part:\[
a_i(f)=\sum_{j=0}^{N-1}w_j\sin (2\pi f j/N)
\]
frequency response can be obtained as \[
a(f) = \frac{\sqrt{a_r^2+a_i^2}}{S_1}
\] where \(S_1 = \sum
_{k=0}^{N-1}w_k\)
rectangle window example
aka. Uniform window, "Rectangular" window, "no window"
Whenever a measurement signal is periodic, a Uniform window is
preferred. Applying a Hanning or Flattop window to a periodic signal
will actually create amplitude and frequency distortion.
When \(f=0\)
\[
a_r(f) + ja_i(f) = \sum_{k=0}^{N-1}w_k = N
\]
When \(f \neq 0\)
\[\begin{align}
a_r(f) + ja_i(f) &= \sum_{k=0}^{N-1} e^{\frac{j2\pi k f}{N}} \\
&= \sum_{k=0}^{N/2} e^{\frac{j2\pi k f}{N}} + e^{\frac{j2\pi (k+N/2)
f}{N}} \\
&= \sum_{k=0}^{N/2} e^{\frac{j2\pi k f}{N}} + e^{j\pi}
e^{\frac{j2\pi k f}{N}} \\
&= \sum_{k=0}^{N/2} e^{\frac{j2\pi k f}{N}} - e^{\frac{j2\pi k
f}{N}} \\
&= 0
\end{align}\]
A Uniform window creates no frequency or amplitude distortion when
the measured signal is periodic.
However, if the signal cannot be guaranteed to be periodic, a Uniform
window should be avoided.
Window Properties
There is no possibility of trade-off between
main-lobe width and sied-lobe amplitude, since the
window length is the only variable parameter.
The rectangular window has the narrowest main lobe for a given
length, i.e. \(\Delta
_{ml}=4\pi/L\)
Other windows include the Bartlett, Hann, and Hamming windows. The
DTFTs of all these windows have main-lobe width \(\Delta _{ml}=8\pi/(L-1)\), which is
approximately twice that of the rectangular window, but they have
significantly smaller side-lobe amplitudes.
figure(1) plot(ff, X, 'r-o', ff, X_rect, 'b-s'); xlabel('Frequency(Hz)'); ylabel('|X|') title('Amplitude spectrum of periodically captured sine wave'); legend('w/ hanning', 'w/ rect'); grid on grid minor % rectangular window provide higher frequency resolution % hanning window induce leakage for the periodically captured sine wave
% fin - 0.5fres fin_lkg0d5 = fin - 0.5*fres; wv_lkg0d5 = cos(2*pi*fin_lkg0d5*tt); power_lkg0d5 = periodogram(wv_lkg0d5, whan, N, fs, 'power'); X_lkg0d5 = (power_lkg0d5).^0.5*2^0.5; psd_lkg0d5 = periodogram(wv_lkg0d5, whan, N, fs, 'psd'); rms_lkg0d5 = sum(psd_lkg0d5*fres)^0.5; fprintf('RMS@-0.5fres & hanning: %.5f\n', rms_lkg0d5);
When using two masks per layer (Double Patterning Technology,
DPT) there is an issue of mask alignment where any
mis-alignment will cause layer spacing values to change, therefore
changing the parasitic coupling capacitance values.
Misalignment scale and direction are not deterministic facts:
coupling cap and total cap may be increased or decreased.
Five new corners are added in a DPT flow to account
for RC variations accurately:
sapced-dependent side-wall dielectric constant also affect coupling
cap
cworst_CCworst, cbest_CCbest, rcworst_CCworst, rcbest_CCbest and
typical
The others are for pre-color RC calculation purpose
**_T** stands for "Tighten DPT corner"; these are
less pessimistic 1.5 sigma corners
Below table is caputre of Aragio's TSMC16: LVDS datasheet
BEOL corner
Spacing variation is implicitly defined by \(\Delta W_m\).
We denote the conductor width and thickness of the layer m
by \(W_m\) and \(T_m\), respectively.
Similarly, we denote the thickness of the layer's interlayer
dielectric (i.e., the distance between layer m and layer m +1) by \(H_m\)
C-based means worst and best caps
RC-based means worst and best R in adjustment
with C (RC product)
Based on experience, it was found that C-based
extraction provides worst and best case over RC for internal
timing paths because Capacitance dominates short
wire.
However, for large design, inter-block timing paths were often worst
with RC worst parasitic since R dominates for
long wires.
T. -B. Chan, S. Dobre and A. B. Kahng, "Improved signoff methodology
with tightened BEOL corners," 2014 IEEE 32nd International Conference on
Computer Design (ICCD), Seoul, Korea (South), 2014, pp. 311-316, doi:
10.1109/ICCD.2014.6974699.
Chan, T. (2014). Mitigation of Variability and Reliability Margins in
IC Implementation /. UC San Diego. ProQuest ID:
Chan_ucsd_0033D_14269. Merritt ID: ark:/20775/bb52916761. Retrieved from
https://escholarship.org/uc/item/35r1m001
Clock Gating is defined as: "Clock gating is a
technique/methodology to turn off the clock to certain parts of the
digital design when not needed".
Clock Gating Overview
AND gate-based clock gating
In simplest form a clock gating can be achieved by using an
AND gate as shown in picture below
However, this simplest form of clock gating technique has some
problem of generating glitches in the clock provide to
the FF, which are not desirable.
Glitches in enable/gated clock
Latch based clock gating
These glitches can be removed by introducing a negative edge
triggered FF (assuming downstream FFs are positive edge) or low-level
sensitive latch at the output of the clock enable signal.
This will make sure that any glitch in the clock enable signal will
not be visible to the gated clock output. The Latch output will only be
updated during the negative clock cycle and thus input to AND gate will
be stable high.
In addition to lowering the required capacitor value, Miller
compensation entails a very important property: it moves the output pole
away from the origin. This effect is called pole
splitting
The 1st stage is replaced with Thevenin equivalent circuit , \(V_i \cong V_i \cdot g_{m1}R_{o1}\)
\[\begin{align}
\frac{V_i-V_{o1}}{R_{o1}} &= V_{o1}\cdot sC_{o1}+(V_{o1}-V_o)\cdot
sC_c \\
V_{o1} &= \frac{V_i+sR_{o1}C_cV_o}{1+sR_{o1}(C_{o1}+C_c)}
\end{align}\]\[
(V_{o1}-V_o)sC_c=g_{m2}V_{o1}+V_o(\frac{1}{R_{o2}+sC_L})
\] substitute \(V_{o1}\), we
get
\(s^3\) terms in denominator \[
H_3 = s^3\cdot(R_{o1}R_{o2}R_c+R_{o1}R_{o2}R_{sw} +R_{o1}R_cR_{sw})\cdot
C_{o1}C_cC_L
\]\(s^2\) terms in denominator
\[\begin{align}
H_2
&=s^2\cdot(R_{o1}R_{o2}C_{o1}C_c+R_{o1}R_{o2}C_{o1}C_L+R_{o2}R_cC_cC_L+R_{o1}R_{o2}C_cC_L+R_{o1}R_cC_{o1}C_c\\
&+R_{o2}R_{sw}C_cC_L+R_{o1}R_{sw}C_cC_L\cdot
g_{m2}R_{o2}+R_{o1}R_{sw}C_{o1}C_L+R_{sw}R_cC_cC_L+R_{o1}R_{sw}C_cC_L)
\end{align}\]
\(s^1\) term in denominator \[
H_1=s(R_{o1}\cdot
g_{m2}R_{o2}C_c+R_{o1}C_{o1}+R_cC_c+R_{o1}C_c+R_{o2}C_c+R_{o2}C_L+R_{sw}C_L)
\]\(s^0\) term in denominator
\[
H_0=1
\] set \(R_c=0\) and \(R_{sw}=0\), the \(H_*\) reduced to \[\begin{align}
H_3 &= 0 \\
H_2 &=s^2R_{o1}R_{o2}(C_{o1}C_c+C_{o1}C_L+C_cC_L) \\
H_1&=s(R_{o1}\cdot
g_{m2}R_{o2}C_c+R_{o1}C_{o1}+R_{o1}C_c+R_{o2}C_c+R_{o2}C_L) \\
H_0&=1
\end{align}\] That is \[
H=s^2R_{o1}R_{o2}(C_{o1}C_c+C_{o1}C_L+C_cC_L)+s(R_{o1}\cdot
g_{m2}R_{o2}C_c+R_{o1}C_{o1}+R_{o1}C_c+R_{o2}C_c+R_{o2}C_L)+1
\]
which is same with our previous analysis of Generic circuit in
textbook
And we know \[
\frac{V_o}{V_{o2}}=\frac{1}{1+sR_{sw}C_L}
\] Finally, we get \(\frac{V_o}{V_i}\)\[\begin{align}
\frac{V_o}{V_i} &= \frac{V_{o2}}{V_i} \cdot \frac{V_o}{V_{o2}} \\
&= -g_{m2}R_{o2}\frac{\left[ sC_c(R_c-1/g_{m2})+1
\right](sR_{sw}C_L+1)}{H_3+H_2+H_1+1} \cdot \frac{1}{1+sR_{sw}C_L} \\
&= -g_{m2}R_{o2}\frac{ sC_c(R_c-1/g_{m2})+1}{H_3+H_2+H_1+1}
\end{align}\]
The loop transfer function is \[
\frac{V_o}{V_i} =-g_{m1}R_{o1}g_{m2}R_{o2}\frac{
sC_c(R_c-1/g_{m2})+1}{H_3+H_2+H_1+1}
\]
The poles can be deduced \[\begin{align}
\omega_1 &= \frac{1}{R_{o1}\cdot g_{m2}R_{o2}C_c} \\
\omega_2 &= \frac{1}{1+g_{m2}R_{sw}}\cdot \frac{g_{m2}}{C_L} \\
&= \frac{1}{(gm_2^{-1}+R_{sw})C_L}
\end{align}\]
The pole \(\omega_2=\frac{1}{gm_2^{-1}C_L}\) is
changed to \(\omega_2=\frac{1}{(gm_2^{-1}+R_{sw})C_L}\)
In order to cancell \(\omega_2\)
with \(\omega_z\), \(R_c\) shall be increased
\[
R_{eq}=g_{m2}^{-1}+R_{sw}
\]
omit \(C_{o1}\) is
same with 2nd system simplification
non-dominant pole in Sansen's
book
Following demonstrate how derive \(f_{nd}\) from Razavi's equation. We copy
\(\omega_2\) here \[
\omega_2 = \frac{R_{o1}C_c\cdot
g_{m2}R_{o2}+R_{o2}(C_c+C_L)+R_{o1}(C_{o1}+C_c)}{R_{o1}R_{o2}(C_cC_{o1}+C_LC_{o1}+C_LC_c)}
\] which can be reduced as below
Any dc current flowing through a diode generates the
so-called "shot noise" due to the random nature of the hole and
electron transitions across the pn junction
Shot noise is not relevant in CMOS devices since it
is only present in bipolar transistors and junction diodes
TIA stage allows for improved gain with better
linearity, as mostly signal current passes through \(R_F\)TODO 📅 ??? Quantitative
analysis
Switched-Capacitor Resistor
\[
R_{eq} = \frac{1}{f_sC}
\]
Channel-Length Modulation
& Pinched off
\(\lambda \propto
\frac{1}{L_g}\)
\(\lambda \propto
\frac{1}{V_{DS}}\)
If \(V_{DS}\) is slightly
greater than \(V_{GS} - V_{TH}\), then
the inversion layer stops at \(x \leq
L\), and we say the channel is "pinched
off"
Upon passing the pinchoff point, the electrons simply shoot through
the depletion region near the drain junction and arrive at the drain
terminal
\(L^{'}\) is the function of
\(V_{DS}\)
with \(\frac{1}{L^{'}} =
\frac{1}{L-\Delta L}=\frac{L+\Delta L}{L^2-\Delta L^2}\approx
\frac{1}{L}\left(1+\frac{\Delta L}{L}\right)\), we have \[
I_D \approx \frac{1}{2}\mu_n C_{ox}\frac{W}{L}\left(1+\frac{\Delta
L}{L}\right)(V_{GS}-V_{TH})^2 = \frac{1}{2}\mu_n
C_{ox}\frac{W}{L}(V_{GS}-V_{TH})^2 (1+\lambda V_{DS})
\] assuming \(\frac{\Delta L}{L} =
\lambda V_{DS}\)
\(\lambda\) represents the
relative variation in length for a given increment in \(V_{DS}\). Thus, for longer channels, \(\lambda\) is smaller
In reality, however, \(r_O\) varies
with \(V_{DS}\). As \(V_{DS}\)increases and the
pinch-off point moves toward the source, the rate at which the
depletion region around the source becomes wider decreases,
resulting in a higher incremental output impedance.
The dependence of offset voltage and current mismatches upon the
overdrive voltage is similar to our observations for corresponding
noise quantities
differential pair
In reality, since mismatches are independent statistical
variables
Above shows that the input transistors must be designed for high
gain (\(g_mr_o =
\frac{2}{V_{OV}\lambda}\)), which means they must be designed for
small\(V_{GS}-V_{TH}\).
It is desirable to minimize \(V_{GS}-V_{TH}\) by lowering the tail
current or increasing the transistor widths
Then, we get \[
V_{os}=\frac{V_o'-V_o}{A}+(V_m'-V_m)
\] Due to \(V_o=V_m\) and \(V_o'=V_m'\)\[
V_{os}=(1/A+1)\Delta{V_m}
\] or \[
V_{os}=(1/A+1)\Delta{V_o}
\] if \(A \gg 1\)\[
V_{os}=\Delta{V_o}
\]
we get \[
V_{os}=\frac{V_o'-V_o}{A}+(V_m'-V_m)
\] or \[
V_{os}=\frac{\Delta V_o}{A}+\beta \Delta V_o
\] if \(A \gg 1\)\[
V_{os}=\beta \Delta V_o
\] or \[
V_{os}=\Delta V_m
\]
Lecture 22 Variability and Mismatch of Dr. Hesham A. Omran's
Analog IC Design
There is discrepancy between model operating point and \(V_{ds}/I_{ds}\)
I believe that the equation \(V_{ds}/I_{ds}\) is more appropriate where
mos is used as switch, though \(V_{ds}=0\) is an outlier.
Schmitt Inverter
gm/ID Intuition
small gm/ID for High ro, or high Early voltage \(V_A\)
Transit Frequency \(f_T\)
Defined as the frequency at which the small-signal current
gain of a device is unity
MOSFET ZTC Condition
Analysis
zero temperature coefficient (ZTC)
MOM cap of wo_mx
Monte Carlo model:
\(C_{pa}=C_{pa1}\), \(C_{pb}=C_{pb1}\) for each iteration during
Process Variation
different variation is applied to \(C_{ab}\) and \(C_{a1b1}\) each iteration during
Mismatch Variation, though \(C_{pa}\), \(C_{pb}\), \(C_{pa1}\) and \(C_{pb1}\) remain constant
\(C_\text{eq}\) and \(R_\text{eq}\) are obtained \[\begin{align}
C_\text{eq} &= \frac{1+|A|^2-2A_r}{1-A_r}\cdot C_f \\
R_\text{eq} &= \frac{A_i}{1+|A|^2-2A_r}\cdot \frac{1}{\omega C_f}
\end{align}\]
D/S small signal model
The Drain and Source of MOS are determined
in DC operating point, i.e. large signal.
That is, top of \(M_2\) is
drain and bottom is source, \[\begin{align}
R_\text{eq2} &= \frac{r_\text{o2}+R_L}{1+g_\text{m2}r_\text{o2}} \\
& \simeq \frac{1}{g_\text{m2}}
\end{align}\]
PMOS small signal model
polarity
The small-signal models of NMOS and PMOS transistors are
identical
A negative \(\Delta V_\text{GS}\)
leads to a negative \(\Delta I_D\).
Recall that \(I_D\), in the
direction shown here, is negative because the actual current of holes
flows from the source to the drain.
Conversely, a positive \(\Delta
V_\text{GS}\) produces a positive \(\Delta I_D\), as is the case for an NMOS
device.
Leakage in MOS
Subthreshold leakage
Drain-Induced Barrier Lowering (DIBL)
Reverse-bias Source/Drain junction leakages
Gate leakage
two other leakage mechanisms
Gate Induced Drain Leakage (GIDL)
Punchthrough
W. M. Elgharbawy and M. A. Bayoumi, "Leakage sources and possible
solutions in nanometer CMOS technologies," in IEEE Circuits and Systems
Magazine, vol. 5, no. 4, pp. 6-17, Fourth Quarter 2005, doi:
10.1109/MCAS.2005.1550165.
X. Qi et al., "Efficient subthreshold leakage current optimization -
Leakage current optimization and layout migration for 90- and 65- nm
ASIC libraries," in IEEE Circuits and Devices Magazine, vol. 22, no. 5,
pp. 39-47, Sept.-Oct. 2006, doi: 10.1109/MCD.2006.272999.
P. Monsurró, S. Pennisi, G. Scotti and A. Trifiletti, "Exploiting the
Body of MOS Devices for High Performance Analog Design," in IEEE
Circuits and Systems Magazine, vol. 11, no. 4, pp. 8-23, Fourthquarter
2011, doi: 10.1109/MCAS.2011.942751.
Andrea Baschirotto, ISSCC2015 "ADC Design in Scaled Technologies"
As a result of DIBL, threshold voltage is reduced
with shorter channel lengths and, consequently, the subthreshold leakage
current is increased
impact on output impedance
The principal impact of DIBL on circuit design is the degraded output
impedance.
In short-channel devices, as \(V_{DS}\) increases further, drain-induced
barrier lowering becomes significant, reducing the threshold
voltage and increasing the drain current
Impact Ionization and GIDL are different, however both
increase drain current, which flowing from the drain into the
substrate
Gate induced drain leakage
(GIDL)
The large current flows from the drain to bulk and this
drain leakage current is named gate-induced drain leakage
(GIDL) since it is due to a gate-induced high electric
field present in the gate-to-drain overlap region
gate-induced drain leakage (GIDL) increases exponentially due to the
reduced gate oxide thickness
Chauhan, Yogesh Singh, et al. FinFET modeling for IC simulation
and design: using the BSIM-CMG standard. Academic Press, 2015.
\[
\frac{g_m}{I_D} = \frac{2}{V_{GS}-V_{TH}}
\] Decrease of gm/Id results from decrease in VT.
GIDL (Gate induced drain leakage) as at weak
inversion may results in a weak lateral electric field causing leakage
current between drain and bulk, which degrade the efficiency of the
transistor (gm/ID).
REF: D. A. Yokoyama-Martin et al., "A Multi-Standard Low Power
1.5-3.125 Gb/s Serial Transceiver in 90nm CMOS," IEEE Custom Integrated
Circuits Conference 2006, 2006, pp. 401-404, doi:
10.1109/CICC.2006.320970.
Power/Ground and I/O Pins
Power / Ground Pin
Information
In both digital and analog I/O, power and ground pins appear at the
sub-circuit definiton, allowing user to use the I/O in voltage islands.
They follow certain naming conventions.
digital I/O sub-circuit
VDD: pre-driver core voltage (supplied by PVDD1CDGM)
VSS: pre-driver ground and also global ground (supplied by
PVDD1CDGM)
VDDPST: I/O post-driver voltage, i.e. 1.8V (supplied by PVDD2CDGM or
PVDD2POCM)
VSSPOST: I/O post-driver ground (supplied by PVDD2CDGM or
PVDD2POCM)
POCCTRL: POCCTRL signal (supplied by PVDD2POCM)
analog I/O placed in a core voltage domain, the convention is
TACVDD: analog core voltage (supplied by PVDD3ACM)
TACVSS: analog core ground (supplied by PVDD3ACM)
VSS: global core ground
analog I/O placed in an I/O voltage domain, the convention is:
TAVDD: analog I/O voltage, i.e. 1.8V (supplied by PVDD3AM)
TAVSS: analog I/O ground (supplied by PVDD3AM)
VSS: global core ground
Power/Ground Combo Cells
power/ground combo pad cell
pins to be connected to bump
to core side pin name
PVDD1CDGM
VDD VSS
VDD VSS
PVDD2CDGM PVDD2POCM
VDDPST VSSPST
N/A
PVDD3AM
TAVDD TAVSS
AVDD AVSS
PVDD3ACM
TACVDD TACVSS
AVDD AVSS
Note for the retention mode
At initial state, IRTE must be 0 when VDD is
off.
IRTE must be kept >= 10us after VDD turns on again (from the
retention mode to the normal operation mode).
IRTE can be switched only when both VDD and VDDPST are on.
When the rention function is needed, IRTE signal must come from an
"always-on" core power domain. If you don't need the rention function,
it is required to tie IRTE to ground. In other words, no matter
the rention feature is needed or not, it is required to have PCBRTE in
each domain.
Note: PCBRTE does not need PAD
connection.
Internal Pins
There are 3 internal global pins, i.e. ESD,
POCCTRL, RTE, in all digital domain
cells.
In real application,
ESD pin is an internal signal and
active in ESD event happening
POCCTRL is an internal signal and active in
Power-on-control event.
However, these special events (i.e. ESD event and Power-on-control
event) are not modeled in NLDM kit (.lib), only normal function is
covered, so ESD and POCCTRL pins are
simply defined as ground in NLDM kit (.lib).
These 3 global pins will be connected automatically after
cell-to-cell abutting in physical layout.
Power-Up sequence in
Digital Domain
Power up the I/O power (VDDPST) first, then the core power (VDD)
PVDDD2POCM cell would generate Power-On-Control signal (POCCTRL) to
have the post-driver NMOS and PMOS off, so that the crowbar current
would not occur in the post-driver fingers when the I/O voltage is on
while the core voltage remains off. As such, I/O cell would be in the
Hi-Z state. when POCCTRL is on, the pll-up/down resistor is disabled and
C is 0.
The POCCTRL signal is transmitted to I/O cells through cell
abutment. There is no need to have routing for POCCTTRL nor
give a control signal to the POCCTRL pin any of I/O cells. Note that the
POCCTRL signal would be cut if inserting a power-cut (PRCUT) cell.
Power-Down sequence in
Digital Domain
It's the reverse of power-up sequence.
Use model in Innovus
1 2 3 4 5 6 7 8 9 10 11 12
set init_gnd_net "vss_core vss DUMMY_ESD DUMMY_POCCTRL"
When a flip-flop samples an input that is changing during its
aperture, the output Q may momentarily take on a voltage between 0 and
VDD that is in the forbidden zone. This is called a metastable state.
Eventually, the flip-flop will resolve the output to a stable state of
either 0 or 1. However, the resolution time required to reach the stable
state is unbounded
M. Tian, V. Visvanathan, J. Hantgan and K. Kundert, "Striving for
small-signal stability," in IEEE Circuits and Devices Magazine, vol. 17,
no. 1, pp. 31-41, Jan. 2001, doi: 10.1109/101.900125.
Ali Sheikholeslami, Circuit Intuitions: Thevenin and Norton
Equivalent Circuits, Part 3 IEEE Solid-State Circuits Magazine, Vol. 10,
Issue 4, pp. 7-8, Fall 2018.
—, Circuit Intuitions: Thevenin and Norton Equivalent Circuits, Part
2 IEEE Solid-State Circuits Magazine, Vol. 10, Issue 3, pp. 7-8, Summer
2018.
—, Circuit Intuitions: Thevenin and Norton Equivalent Circuits, Part
1 IEEE Solid-State Circuits Magazine, Vol. 10, Issue 2, pp. 7-8, Spring
2018.
—, Circuit Intuitions: Miller's Approximation IEEE Solid-State
Circuits Magazine, Vol. 7, Issue 4, pp. 7-8, Fall 2015.
Mismatch between the pole and zero frequencies leads to the
“doublet problem”. If the pole and the zero do not
exactly coincide, we say that they constitute a
doublet
Problem 10.19 in Razavi 2nd book
Suppose the open-loop transfer function of a two-stage op amp is
expressed as \[
H_{open}(s)=\frac{A_0(1+\frac{s}{\omega_z})}{\left( 1+
\frac{s}{\omega_{p1}}\right)\left( 1+ \frac{s}{\omega_{p2}}\right)}
\] Ideally, \(\omega_z=\omega_2\) and the feedback
circuit exhibits a first-order behavior, i.e., its step response
contains a single time constant and no overshoot.
Then the transfer function of the amplifier in a unity-gain
feedback loop is given by \[\begin{align}
H_{closed}(s)
&=\frac{A_0\left(1+\frac{s}{\omega_z}\right)}{\frac{s^2}{\omega_{p1}\omega_{p2}}+\left(
\frac{1}{\omega_{p1}} +
\frac{1}{\omega_{p2}}+\frac{A_0}{\omega_{z}}\right)s+A_0+1} \\
&=\frac{\frac{A_0}{A_0+1}(1+\frac{s}{\omega_z})}{\frac{s^2}{\omega_{p1}\omega_{p2}(A_0+1)}+\left(
\frac{1}{\omega_{p1}} +
\frac{1}{\omega_{p2}}+\frac{A_0}{\omega_{z}}\right)\frac{s}{A_0+1}+1}
\end{align}\]
The denominator part of \(H_{closed}(s)\) is \[
D(s) = \frac{s^2}{\omega_{p1}\omega_{p2}}+\left( \frac{1}{\omega_{p1}} +
\frac{1}{\omega_{p2}}+\frac{A_0}{\omega_{z}}\right)s+A_0+1
\]
Assuming two poles (\(\omega_{pA}
\ll\omega_{pB}\)) of \(H_{closed}(s)\) are widely spaced, \[\begin{align}
D(s) &= \left( 1+ \frac{s}{\omega_{pA}}\right)\left( 1+
\frac{s}{\omega_{pB}}\right)\\
&\cong \frac{s^2}{\omega_{pA}\omega_{pB}}+\frac{s}{\omega_{pA}} + 1
\end{align}\]
Thus, the two poles of the closed-loop transfer function of system
are \[\begin{align}
\omega_{pA} &= \frac{A_0+1}{\frac{1}{\omega_{p1}} +
\frac{1}{\omega_{p2}}+\frac{A_0}{\omega_{z}}} \\
&= \frac{(A_0+1)\omega_{p1} \omega_{p2}}{\omega_{p1} + \omega_{p2}
+ \frac{A_0}{\omega_z}\omega_{p1} \omega_{p2}} \\
\omega_{pB} &= \omega_{p1} + \omega_{p2} +
\frac{A_0}{\omega_z}\omega_{p1} \omega_{p2}
\end{align}\]
Assuming\(\omega_z \simeq
\omega_{p2}\) and \(\omega_{p2}\ll
(1+A_0)\omega_{p1}\)\[
\omega_{pA} = \omega_{p2}
\] and \[
\omega_{pB} = (1+A_0)\omega_{p1}
\] The closed-loop transfer function is \[
H_{closed}(s) =
\frac{\frac{A_0}{A_0+1}\left(1+\frac{s}{\omega_z}\right)}{\left(1+\frac{s}{(1+A_0)\omega_{p1}}\right)\left(
1+\frac{s}{\omega_{p2}} \right)}
\]
The step response of the closed-loop amplifier
Consider the Laplace transform function of step response, \(X(s)=\frac{1}{s}\)\[
Y(s)=\frac{1}{s}\times H_{closed}(s)
\] Thus, the small-signal step response of the
closed-loop amplifier is \[
y(t)=\frac{A_0}{A_0+1}\left[1-e^{-(A_0+1)\omega_{p1}t}-\left(1-\frac{\omega_{p2}}{\omega_z}\right)e^{-\omega_{p2}t}
\right]u(t)
\] Since, \(\omega_{p2}\ll
(1+A_0)\omega_{p1}\). Therefore, rewrite the \(y(t)\)\[
y(t)\cong
\frac{A_0}{A_0+1}\left[1-\left(1-\frac{\omega_{p2}}{\omega_z}\right)e^{-\omega_{p2}t}
\right]u(t)
\] The step response contains an exponential term of the form
\(\left(1-\frac{\omega_{p2}}{\omega_z}\right)e^{-\omega_{p2}t}\).
This is an important result, indicating that if the zero does not
exactly cancel the pole, the step response exhibits an exponential with
an amplitude proportional to \(\left(1-\frac{\omega_{p2}}{\omega_z}\right)\),
which depends on the mismatch between \(\omega_z\) and \(\omega_{p2}\) and a time constant \(\tau\) of \(\frac{1}{\omega_{p2}}\) or \(\frac{1}{\omega_{z}}\)
B. Y. T. Kamath, R. G. Meyer and P. R. Gray, "Relationship between
frequency response and settling time of operational amplifiers," in IEEE
Journal of Solid-State Circuits, vol. 9, no. 6, pp. 347-352, Dec. 1974,
[https://sci-hub.se/10.1109/JSSC.1974.1050527]
P. R. Gray and R. G. Meyer, "MOS operational amplifier design-a
tutorial overview," in IEEE Journal of Solid-State Circuits, vol. 17,
no. 6, pp. 969-982, Dec. 1982, [https://sci-hub.se/10.1109/JSSC.1982.1051851]
—. 2024. Analysis and Design of Analog Integrated Circuits, 6th
Edition. Wiley Publishing
The most accurate method to calculate the degradation of transistors
is the SPICE-level simulation of the whole netlist with application
programming interface (API) and industry-standard stress process
models
MOSRA: MOSFET reliability analysis Synopsys
RelXpert: Cadence
TMI: TSMC Model Interface, TSMC
OMI: Open Model Interface, Si2 standard,
The Silicon Integration Initiative (Si2) Compact Model Coalition has
released the Open Model Interface, an Si2 standard, C-language
application programming interface that supports SPICE compact model
extensions.OMI allows circuit designers to simulate and analyze such
important physical effects as self-heating and aging,
and perform extended design optimizations. It is based on TMI2, the TSMC
Model Interface, which was donated to Si2 by TSMC in 2014.
TDDB: Time-Dependent Dielectric Breakdown
HCI: Hot Carrier injection
BTI: Bias Temperature Instability
NBTI: Negative Bias Temperature Instability
PBTI: Positive Bias Temperature Instability
SHE: Self-Heating Effect
Aging & SHE in FinFET
SHE
Self-Heating & EM
Heat Sink (HS)
guard ring
closer OD help reduce dT
extended gate
source/drain metal stack
Bias Temperature Instability
(BTI)
BTI occurs predominantly in PMOS (or p-type or p channel)
transistors and causes an increase in the transistor's absolute
threshold voltage.
Stress in the case of NBTI means that the PMOS transistor is
in inversion; that means that its gate to
body potential is substantially below 0 V for analogue circuits
or at VGB = −VDD for digital circuits
Higher voltages and higher temperatures both have
an exponential impact onto the degradation, induced by NBTI.
NBTI will be accelaerated with thinner gate oxide, at a high
temperature and at a high electric field across the oxide region.
During recovery phase where the gate voltage of pMOS is high and
stress is removed, the H atoms in the gate oxiede diffuse back to
Si-SiO2 interface and the recombination of Si-H bonds reduces the
threshold voltage of pMOS.
The net result is an increase in the magnitude of the device
threshold voltage |Vt|, and a degradation of the
channel carrier mobility.
Caution: The aging model provided by fab may
NOT contain recovry effect
HCI
Short-channel MOSFETs may exprience high lateral electric
fields if the drain-source voltage is large. while the average
velocity of carriers saturate at high fields, the instantaneous velocity
and hence the kinetic energy of the carriers continue to increase,
especially as they accelerate toward the drain. These are called
hot carriers.
In nanometer technologies, hot carrier effects have
subsided. This is because the energy required to create
an electron-hole pair, \(E_g \simeq 1.12
eV\), is simply not available if the supply voltage is around
1V.
\[
F_E= E \cdot q
\]
\[\begin{align}
E_k &= F_E \cdot s \\
&= E \cdot q \cdot s
\end{align}\]
Electrons and holes gaining high kinetic energies in
the electric field (hot carriers) may be injected into
the gate oxide and cause permanent changes in the
oxide-interface charge distribution, degrading the current-voltage
characteristics of the MOSFET.
The channel hot-electron (CHE) effect is caused by electons flowing
in the channel region, from the source to the drain. This effect is more
pronounced at large drain-to-source voltage, at which the lateral
electric field in the drain end of the channel accelerates the
electrons.
Four different hot carrier injectoin mechanisms can be distinguished:
- channel hot electron (CHE) injection - drain avalanche hot carrier
(DAHC) injection - secondary generated hot electron (SGHE) injection -
substrate hot electron (SHE) injection
HCI is more of a drain-localized mechanism, and is
primarily a carrier mobility degradation (and a Vt
degradation if the device is operated bi-directionally).
For smaller transistor dimensions, CHE dominates the hot
carrier degradation effect
The hot-carrier induced damage in nMOS transistors has been found to
result in either trapping of carriers on defect sites in the oxide or
the creation of interface states at the silicon-oxide interface, or
both.
The damage caused by hot-carrier injection affects the transistor
characteristics by causing a degradation in transconductance, a shift in
the threshold voltage, and a general decrease in the drain current
capability.
HCI seems to have just a weak temperature
dependency. Unlike BTI, it seems to be no or just little recovery. As
holes are much "cooler" (i.e. heavier) than electrons, the channel hot
carrier effect in nMOS devices is shown to be more significant than in
pMOS devices.
Degradation saturation
effect
HCI model can reproduce the saturation effect if stress time is long
enough
TDDB
TDDB effect is also related to oxide traps. In general, TDDB refers
to the loss of isolating properties of a dielectric layer. If this
dielectric layer is the gate oxide, TDDB will initially lead to an
increase in the gate tunnelling current.
This soft breakdown can already lead to a parametric degradation.
After a long accumulation period, TDDB leads to a catastrophic reduction
of the channel to gate insulation and thus a functional failure of the
transistor.
Scaling drive more concerns in TDDB
waveform-dependent nature
The figure below illustrates the waveform-dependent nature of these
mechanisms – as described earlier, BTI and HCI depend upon the region of
active device operation. The slew rate of the circuit inputs and output
will have a significant impact upon these mechanisms, especially
HCI.
Negative bias temperature instability (NBTI). This
is caused by constant electric fields degrading the dielectric,
which in turn causes the threshold voltage of the transistor to degrade.
That leads to lower switching speeds. This effect depends on the
activity level of the circuits, with heavier impact on parts of the
design that don’t switch as often, such as gated clocks,
control logic, and reset, programming and test circuitry.
Hot carrier injection (HCI). This is caused by
fast-moving electrons inserting themselves into the gate and
degrading performance. It primarily occurs on higher-voltage modes and
fast switching signals.
longer channel length help both BTI and HCI
larger\(V_{ds}\) help
BTI, but hurt HCI
lower temperature help BTI of core device, but hurt that of
IO device for 7nm FinFET
MOSRA
MOSRA is a 2-step simulation: 1) Age computation, 2) Post-age
analysis
TMI
BTI recovery effect NOT included for N7
Stochastic Nature
of Reliability Mechanisms
A fraction of devices will fail
Circuit Simulations
Heat transfer, thermal
resistance
reference
Spectre Tech Tips: Device Aging? Yes, even Silicon wears out -
Analog/Custom Design (Analog/Custom design) - Cadence Blogs - Cadence
Community https://shar.es/afd31p
A. Zhang et al., "Reliability variability simulation methodology for
IC design: An EDA perspective," 2015 IEEE International Electron Devices
Meeting (IEDM), Washington, DC, USA, 2015, pp. 11.5.1-11.5.4, doi:
10.1109/IEDM.2015.7409677.
W. -K. Lee et al., "Unifying self-heating and aging simulations with
TMI2," 2014 International Conference on Simulation of Semiconductor
Processes and Devices (SISPAD), Yokohama, Japan, 2014, pp. 333-336, doi:
10.1109/SISPAD.2014.6931631.
Article (20482350) Title: Measure the Impact of Aging in Spectre
Technology URL:
https://support.cadence.com/apex/ArticleAttachmentPortal?id=a1O0V000009ESBFUA4
Karimi, Naghmeh, Thorben Moos and Amir Moradi. “Exploring the Effect
of Device Aging on Static Power Analysis Attacks.” IACR Trans. Cryptogr.
Hardw. Embed. Syst. 2019 (2019): 233-256.[link]
Y. Zhao and Y. Qu, "Impact of Self-Heating Effect on Transistor
Characterization and Reliability Issues in Sub-10 nm Technology Nodes,"
in IEEE Journal of the Electron Devices Society, vol. 7, pp. 829-836,
2019, doi: 10.1109/JEDS.2019.2911085.
When set to aocv_multiplicative, the derating factor
will be calculated as AOCV derating * OCV derating, which is set using
the set_timing_derate command.
When set to aocv_additive, the derating factor will be
calculated as AOCV derating + OCV derating values.
When you use this global variable, the report_timing
command shows the total_derate column in the timing report
output, which allows you to view and cross-check the calculated total
derate factor.
To set this global variable, use the set_global
command.
reference
Genus Attribute Reference 22.1
Innovus Text Command Reference 22.10
Article (20416394) Title: Analysis with Advanced On-chip Variation
(AOCV) derating in EDI system and ETS URL:
https://support.cadence.com/apex/ArticleAttachmentPortal?id=a1Od000000050NxEAI