Listing of GNU/Octave code for RC low-pass filter. Used to generated the graphs in my RC low-pass filter article. Supplements the article RLC Low-pass Filter.\(\)
Appendix
Step response, in GNU/Octave
clc; close all; clear all; format short eng
L=47e-3; # 47mH
C=47e-9; # 47nF
#Rvector = [3.9e3]; # separate real poles
#Rvector = [2e3]; # coinciding real poles
#Rvector = [220 820 1500]; # conjugate complex poles
Rvector = [0]; # conjugate complex poles on im-axis
w=logspace(3,5,200); #*e.^(sigma*t)
f=w/(2*pi);
for R = Rvector
wn=1/sqrt(L*C);
zeta=R/2*sqrt(C/L)
t=linspace(0,2e-3,200);
if (zeta < 1) # complex conjugate poles
sigma=wn*zeta;
wd=wn*sqrt(1-zeta^2);
u=1 - sqrt(sigma^2+wd^2)/wd .* exp(-sigma*t) .* cos(wd*t-atan(sigma/wd));
hold on; h=plot(t,u); hold off;
endif
if (zeta == 1) # coinciding real poles
p=wn*(-zeta+sqrt(zeta^2-1));
u=1 + (p*t-1).*e.^(p*t);
hold on; h=plot(t,u); hold off;
endif
if (zeta > 1) # real poles
p1=wn*(-zeta+sqrt(zeta^2-1));
p2=wn*(-zeta-sqrt(zeta^2-1));
u = 1 + p2/(p1-p2)*e.^(p1*t) + p1/(p2-p1)*e.^(p1*t);
hold on; h=plot(t,u); hold off;
endif
endfor
axis([min(t) max(t) 0 2]); #1.75
xlabel('time [s]'); ylabel('|h(t)|');
t=['Step Response(t'];
t2=['), C=' num2str(C*1e9) 'nF, L=', num2str(L*1e3),'mH'];
if(length(Rvector)==1)
t=[t t2 ', R=' num2str(R/1e3) 'k\Omega']
else
t=[t ',R' t2];
legend(strread(num2str(Rvector,3),'%s'));
endif
t = [t ];
title(t, "fontsize", 15);
Bode magnitude, in GNU/Octave
clc; close all; clear all; format short eng
L=47e-3; # 47mH
C=47e-9; # 47nF
#Rvector = [3.9e3]; # separate real poles
#Rvector = [2e3]; # coinciding real poles
#Rvector = [220 820 1500]; # conjugate complex poles
Rvector = [0]; # conjugate complex poles on im-axis
f=logspace(1,6,200);
w=2*pi*f;
for R = Rvector
wn=1/sqrt(L*C);
zeta=R/2*sqrt(C/L)
if (zeta == 0) # complex conjugate poles on imaginary axis
u=20*log10(wn.^2) - 20*log10(wn.^2-w.^2);
hold on; h=semilogx(f,u); hold off;
hold on;
plot([wn/(2*pi) wn/(2*pi)], get(gca,'YLim'),'k--');
text(wn/(2*pi)*1.1,30,'|p|/2\pi');
hold off
poles = [-wn*zeta+sqrt(1-zeta^2)*j, -wn*zeta-sqrt(1-zeta^2)*j ];
endif
if (zeta < 1 && zeta > 0) # complex conjugate poles on left side of s-plane
u=20*log10(wn.^2) - 20*log10(sqrt((wn.^2-w.^2).^2+(2*zeta*wn*w).^2));
hold on; h=semilogx(f,u); hold off;
hold on;
plot([wn/(2*pi) wn/(2*pi)], get(gca,'YLim'),'k--');
text(wn/(2*pi),25,'\omega_n/2\pi');
hold off
poles = [-wn*zeta+sqrt(1-zeta^2)*j, -wn*zeta-sqrt(1-zeta^2)*j ];
endif
if (zeta == 1) # coinciding real poles
p=1/sqrt(L*C);
u=20*log10(p.^2) - 40*log10(sqrt(w.^2+p.^2));
hold on; h=semilogx(f,u);
plot([wn/(2*pi) wn/(2*pi)], get(gca,'YLim'),'k--');
text(wn/(2*pi),5,'|p|/2\pi');
f1=p/(2*pi);
fmax=max(f);
asymp=-40*log10((fmax-f1)/f1);
plot([min(f) f1 fmax],[0 0 asymp ],'k--');
hold off
poles=[-wn*zeta -wn*zeta];
endif
if (zeta > 1) # separate real poles
p1=wn*(-zeta+sqrt(zeta^2-1));
p2=wn*(-zeta-sqrt(zeta^2-1));
u=20*log10(p1*p2./(sqrt(w.^2+p1.^2).*sqrt(w.^2+p2.^2)));
figure(1);
hold on; h=semilogx(f,u); hold off;
hold on;
f1=-p1/(2*pi); f2=-p2/(2*pi);
plot([f1 f1], get(gca,'YLim'),'k--');
plot([f2 f2], get(gca,'YLim'),'k--');
fmax=max(f);
asymp1=0 - 20*log10((f2-f1)/f1);
asymp2=asymp1 - 40*log10((fmax-f2)/f2);
plot([min(f) f1 f2 fmax],[0 0 asymp1 asymp2],'k--');
text(f1,5,'|p1|/2\pi');
text(f2,5,'|p2|/2\pi');
hold off
poles=[p1+0j p2+0j];
endif
endfor
figure(1);
grid off;
axis([min(f) max(f) -80 40]);
xlabel('frequency [Hz]'); ylabel('20log| H(t)|');
leg=strread(num2str(Rvector,4),'%s');
if (zeta>=1)
leg=[leg;'asymptote'];
endif
t=['Bode Magnitude in dB(f'];
t2=['), C=' num2str(C*1e9) 'nF, L=', num2str(L*1e3),'mH'];
if(length(Rvector)==1)
t=[t t2 ', R=' num2str(R/1e3) 'k\Omega']
else
t=[t ',R' t2];
legend(leg);
endif
t = [t ];
title(t, "fontsize", 15);
Shows the math of a underdamped RLC low pass filter. Visualizes the poles in the Laplace domain. The step and frequency response. Part of the article RLC Low-pass Filter.\(\)
Complex Poles (underdamped case)
For complex conjugate poles, the transfer function can be written as below. Given that \(\zeta\lt1\), the argument of the square root in the poles will be negative. Multiply this argument with \(-j^2\) to highlight the imaginary part apart.
Split the conjugate poles in their real and imaginary parts by defining the poles from equation \(\eqref{eq:case3a_transferpoles}\) as \(p,\,p^*\equiv -\sigma\pm j\omega_d\)
This equation indicates that the conjugate poles \(p, p^*\) lay in the left half of the \(s\)-plane. The length of the line segment from the origin to pole \(p\) represents the natural frequency \(\omega_n\) and the angle of the imaginary axis with that line is \(\arcsin\) of the attenuation \(\zeta\). [MIT-me]
\(s\)-plane for underdamped case
Unit Step Response
Multiplication of the Laplace transform of the unit step function, \(\Gamma(s)\), with the transfer function \(\eqref{eq:case3a_transferpoles}\) gives the unit step response \(Y(s)\).
The constants \(c_1\) and \(c_2\) are complex conjugates of each other since they are equivalent except for the sign on the imaginary part. To highlight this, substitute the values for the poles from \(\eqref{eq:sigmaomegad}\) and write these constants in polar notation
The unit step response \(y(t)\) follows from the inverse Laplace transform of \(\eqref{eq:case3a_heaviside}\), substituting \(c_{0,1,2}\) from \(\eqref{eq:case3a_constants}\), \(\eqref{eq:case3a_c2polar}\) and \(\eqref{eq:case3a_c3polar}\).
Apply the Euler identify for cosine, and reference \(|p|\) and \(\varphi\) from equation \(\eqref{eq:case3a_c2polar}\) and \(\eqref{eq:case3a_c3polar}\), \(\sigma\) and \(\omega_d\) from equation \(\eqref{eq:sigmaomegad}\) and \(\zeta\) and \(\omega_n\) from \(\eqref{eq:case3a_transferpoles}\)
The graph shows the response for different values of \(R\). This underdamped circuit oscillates, with the amplitude exceeding that of the input (\(1\)).
Step response for underdamped case
For the extreme case, where \(R=0\), the response becomes \(\left(1-cos(\omega_n t)\right)\gamma(t)\), oscillating with an amplitude reaching twice the input (\(1\)).
Frequency Response
The frequency response \(y_{ss}(t)\) is defined as the steady state response to a sinusoidal input signal
$$
u(t)=\sin(\omega t)\,\gamma(t)
$$
We can rewrite the transfer functionby substituting the poles from \(\eqref{eq:sigmaomegad}\)
This transfer function with the poles at \(p\) and \(p^\ast\), evaluated for \(s=j\omega\) can be visualized with vectors from the poles to \(j\omega\).
Transfer function evaluated at \(s=j\omega\) for underdamped case1a_constants
Substitute \(s=j\omega\) into the transfer function \(\eqref{eq:case3a_newhs}\)
The graph shows the magnitude of the output for different values of \(R\). The magnitude of the frequency response demonstrates resonant behavior. Note the voltage amplification around the natural frequency \(\omega_n\) .
Bode magnitude for underdamped case
The corresponding Nyquist plot shows that the system gets less stable as the resistor value decreases
Shows the math of a critically-damped RLC low pass filter. Visualizes the poles in the Laplace domain. Visualizes the step and frequency response. Part of the article RLC Low-pass Filter.\(\)
Coinciting Real Poles (critically-damped case)
In the critically-damped case, the two poles from the transfer polynominal coincite on the negative real axis.
Split up this complicated fraction into forms that are in the Laplace Transform table. According to Heaviside, this can be expressed as partial fractions. Note the factor \(\frac{c_2}{s-p}\). [swarthmore, MIT-cu]
Given \(c_0\) and \(c_1\), constant \(c_2\) can be found by substituting any numerical value (other than \(0\) or \(p\)) in equation \(\eqref{eq:case2a_heaviside}\). In this case, we substitute \(s=-p\) [MIT-ex4]
As shown in the graph below, this unit step response is a relatively fast rising exponential curve, demonstrating the shortest possible rise time without overshoot.
Step response for critically-damped case
Frequency Response
The frequency response \(y_{ss}(t)\) is defined as the steady state response to a sinusoidal input signal \(u(t)=\sin(\omega t)\,\gamma(t)\).
This transfer function with the double poles at \(p\), evaluated for \(s=j\omega\) can be visualized with vectors from the poles to \(j\omega\).
Transfer function evaluated at \(s=j\omega\) for critically-damped case
The square of the length of the vector corresponds to \(|(H(j\omega)|\), and minus twice the angles with the real axis corresponds to phase shift \(\angle H(j\omega)\).
Shows the math of a overdamped RLC low pass filter. Visualizes the poles in the Laplace domain. Calculates the step and frequency response. Part of the article RLC Low-pass Filter.\(\)
>
Two Different Real Poles (overdamped case)
The two poles from the transfer polynominal are on separate locations on the negative real axis.
Note that \(p_1\lt p_2\lt0\) and \(|p_1|>|p_2|\), as visualized in the \(s\)-plane
\(s\)-plane for overdamped case
Unit Step Response
The unit step response shows how the system reacts to the input going from \(0\) to \(1\) volt at time \(t=0\). This input is called the Unit Step Function, here represented by \(u(t)=\gamma(t)\). The unit step response gives an impression of the system behavior in the time domain.
Split up this complicated fraction into forms that are in the Laplace Transform table. According to Heaviside, this can be expressed as partial fractions. Note that we need to set up a partial fraction for each descending power of the denominator. [swarthmore, MIT-cu]
The unit step response \(y(t)\) follows from the inverse Laplace transform of \(\eqref{eq:case1a_heaviside}\) and substituting the constants \(\eqref{eq:case1a_constants}\)
As shown in the graph, the unit step response is a relatively slow decaying exponential curve (with \(p_1\lt p_2\lt 0\)). The figure was generated using the source code listed in the appendix.
Unit step response for over dampened case
Frequency Response
The frequency response \(y_{ss}(t)\) is defined as the steady state response to a sinusoidal input signal \(u(t)=\sin(\omega t)\,\gamma(t)\). It describes how well the filter can distinguish between different frequencies.
This transfer function with poles at \(p_1\) and \(p_2\), evaluated for \(s=j\omega\) can be visualized with vectors from the poles to \(j\omega\).
Transfer function evaluated at \(s=j\omega\) for over dampened case
The product of the length of the vector corresponds to \(|(H(j\omega)|\), and minus the sum of the angles with the real axis corresponds to phase shift \(\angle H(j\omega)\).
Solves the differential equation for a RC low-pass filter. Gives the homogeneous and particular solutions. This supplements the article RC Low-pass filter.\(\)
Appendix B
For old times sake, we show the traditional method to solve the differential equation for the passive filters consisting of a resistor and capacitor in series.
The output is the voltage over the capacitor \(y(t)\) as shown in the schematic below.
Schematic RC filter
Assume a switch between the input and the resistor that closes at \(t=t_1\). Further assume \(y(t\leq t_1)=Y_0\).
According to Kirchhoff’s Voltage Law, for \(t\geq t_1\)
If \(u(t)\) is continuous, we can choose either differential equation, but when \(u(t)\) is non-continuous we can’t use \(\eqref{eq:bDV2}\).
Assume the non-homogeneous linear differential equation of a first order High-pass LC-filter, where \(u(t)=\hat{u}\cos(\omega t)\) is the forcing function and the current \(i(t)\) through the inductor is the response. The differential equation for this system is
The solution is a superposition of the natural response and a forced response. The so called, homogeneous solution \(y_h(t)\) and the particular solution \(y_p(t)\)
$$
y(t)=y_h(t)+y_p(t)\label{eq:bTrigRC_hp}
$$
Homogeneous solution
The homogeneous solutions follows from the reduced (=homogeneous) linear differential equation where the forcing function is zero.
The solution base \(y_{h,1}(t)\) follows from substituting the root \(p\) from equation \(\eqref{eq:bTrigRC_p}\) in back in the homogeneous differential equation \(\eqref{eq:bTrigRC_gen}\)
$$
y_{h1}(t)=\mathrm{e}^{-\frac{t}{RC}t}
$$
The homogeneous solution follows as a linear combination of the solution bases (only one in this case) as
where the constant \(c\) follows from the initial conditions.
Particular solution
We will show how to get the particular solution using both trigonometry and complex arithmetic.
Using the trigonometry method
If we force a signal \(\hat{u}\cos(\omega t)\) on a linear system, the output will have the same frequency but with a different phase \(\phi\) and amplitude \(A\).
by assigning the two independent variables \(R\) and \(\omega L\) to two more convenient independent variables \(\gamma\cos\alpha\) and \(\gamma\sin\alpha\)
Divide \(\eqref{eq:bTrigRC_CsinAlpha}\) by \(\eqref{eq:bTrigRC_CcosAlpha}\) to solve for \(\alpha\), and apply the geometric identity \(\sin^2\alpha+\cos^2\alpha=1\) to \(\eqref{eq:bTrigRC_CsinAlpha}\) by \(\eqref{eq:bTrigRC_CcosAlpha}\) to solve for \(C\)
Using a complex forcing function \(\underline{u}(t)\) provides a less involved method of finding the particular solution as introduced in Linear Differential Equations. Using a complex forcing function
Since the forcing function was only the real part of \(\underline{u}(t)\), are only interested in the real part of the complex particular solution \(\eqref{eq:bRLSol}\) as well
The general solution follows from substituting \(\eqref{eq:bTrigRC_hSolution}\) and \(\eqref{eq:bTrigRC_pSolution}\text{ or }\eqref{eq:bCaRC_pSolution}\) in equation \(\eqref{eq:bTrigRC_hp}\).
Listing of GNU/Octave code for RC low-pass filter. Used to generated the graphs in my RC low-pass filter article. This supplements the article RC Low-pass filter.
Appendix A
Unit Step Response in GNU/Octave
GNU/Octave code for RC low-pass filter
clc; close all; clear all; format short eng
R=100; # 100Ohm
C=470e-9; # 470nF
w=logspace(3,5,200);
f=w/(2*pi);
t=linspace(0,2e-3,200);
p=-1/(R*C);
u=1-e.^(p*t);
h=plot(t,u);
axis([min(t) max(t) 0 2]); #1.75
xlabel('time [s]'); ylabel('|h(t)|');
t=['Step Response(t), C=' num2str(C*1e9) 'nF, R=' num2str(R) '\Omega']
title(t, "fontsize", 15);
Frequency Response in GNU/Octave
GNU/Octave code for RC low-pass filter
clc; close all; clear all; format short eng
R=100; # 100Ohm
C=470e-9; # 470nF
f=logspace(1,6,200);
w=2*pi*f;
p=-1/(R*C);
u=-20*log10(sqrt(1+(w*R*C).^2));
h=semilogx(f,u); hold on;
wn=-p;
plot([wn/(2*pi) wn/(2*pi)], get(gca,'YLim'),'k--');
text(wn/(2*pi),5,'|p|/2\pi');
f1=-p/(2*pi);
fmax=max(f);
asymp=-20*log10((fmax-f1)/f1);
plot([min(f) f1 fmax],[0 0 asymp ],'k--');
hold off
poles=[-p -p];
figure(1);
grid off;
axis([min(f) max(f) -80 40]);
xlabel('frequency [Hz]'); ylabel('20log| H(t)|');
leg=[strread(num2str(R,1),'%s');'asymptote'];
t=['Bode Magnitude in dB(f), C=' num2str(C*1e9) 'nF, R=' num2str(R) '\Omega'];
title(t, "fontsize", 15);
hold off;
Nyquist Diagram in GNU/Octave
GNU/Octave code for RC low-pass filter
clc; close all; clear all; format short eng
pkg load control
R=100; # 100Ohm
C=470e-9; # 470nF
p=-1/(R*C);
H = tf([-p], [ 1 -p ]);
[mag, phi, w] = bode(H);
nyquist(H); h=gcf;
axis ([-0.2, 1.2, -.7, .7], "square");
Square Wave in GNU/Octave
clf;
t=linspace(0,2e-3,1e4); # t from 0 to 2 msec, with 10,000 steps
f=2e3; # input frequency [Hz]
R=100; # 100 Ohms
C=470e-9; # 470 nF
M=1e5; # number of harmonics
ut=0; # input signal (square wave)
yt=0; # output signal
w=2*pi*f; # omega
fc=1/(2*pi*R*C) # cutoff (-3dB) frequency
for n=1:2:M,
nwt = n*w*t;
nwRC = n*w*R*C;
ut = ut + 4/pi * sin(nwt) / n;
argH = 1 / sqrt( 1 + nwRC^2 );
angH = -atan(nwRC);
yt = yt + 4/pi * argH * sin(nwt + angH) / n;
end
plot(t*1e3,ut, 'b-',t*1e3,yt)
title('Square Wave input to RC filter')
xlabel('t [msec]')
ylabel('[Volt]')
grid on;
legend('u(t)','y(t)')
saveas(1,"square.svg")
Derives the frequency response of RC low-pass filter using the Laplace transform. Part of a series about the properties of the RC low-pass filter.\(\)
Frequency Response
The frequency response \(y_{ss}(t)\) is defined as the steady state response to a sinusoidal input signal \(u(t)=\sin(\omega t)\,\gamma(t)\). It describes how well the filter can distinguish between different frequencies.
This frequency response for different frequencies can be visualized in a Bode plot or a Nyquist diagram. Each of these are a topic of the remaining sections.
Effect on Input with Harmonics
As a side step, we examine the effect of the filter on a square wave input signal. The Fourier series of the square wave shows that it consists of a base frequency and odd harmonics.
A Bode plots frequency as the horizontal axis and usually consists of two separate plots to that show the magnitude and phase of the frequency response \(y_{tt}\). Since the range of magnitudes may also be large, the amplitude scale is usually expressed in decibels \(20\log_{10}\left|H(j\omega)\right|\) . The frequency axis uses a logarithmic scale as well.
The magnitude of the frequency response has a relatively shallow drop-off.
Frequency response
The phase shift depends on the frequency, causing signals composed of multiple frequencies to be distorted.
Angular frequency \(\omega_c=|p|\), is is known as the cutoff, break, -3dB or half-power frequency because the magnitude of the transfer function \(\eqref{eq:polar2}\) equals \(1/\sqrt{2}\)
This single-pole filter gives has a relatively shallow -20 dB/decade drop-off.
In general, the cutoff frequency is equal to the radial distance of the poles or zeros from the origin of the \(s\)-plane. For information on sketching the Bode magnitude plot from the poles and zeros, refer to Understanding Poles and Zeros [MIT 3.1].
Nyquist plot
The Nyquist plots display both amplitude and phase angle on a single plot, using the angular frequency as the parameter. It helps visualize if a system is stable or unstable.
Plot the frequency transfer function for \(-\infty\lt\omega\gt\infty\), indicating an increase of frequency using an arrow. A dashed line is used for negative frequencies. (The plot was generated using the GNU/Octave as shown in Appendix A.)
Nyquist diagram
From the plot we see that for \(\omega=0\) the gain is 1, and for \(\omega\to\infty\) the gain becomes 0. The high frequency portion of the plot approaches the origin at an angle of -90 degrees. For more information on Nyquist refer to Determining Stability using the Nyquist Plot [swarthmore].
Finished with “Frequency response of RC low-pass filter?”, learn about:
Derives the unit step response of RC low-pass filter. Part of a series about the properties of the RC low-pass filter.\(\)
Unit Step Response
The step response gives an impression of the system behavior when the input signal going from \(0\) to \(1\) volt at time \(t=0\). This input is called the Unit Step Function, here represented by \(u(t)=\gamma(t)\).
Split up this complicated fraction into forms that are in the Laplace Transform table. According to Heaviside, this can be expressed as partial fractions. [swarthmore, MIT-cu]
Substitute \(K=-p\) from the transfer function and find expressions for the constants \(c_{0,1}\), by multiplying with respectively \(s\) and \((s-p)\)
Derives the bandwidth and Q-factor of a RLC resonator. Visualizes the Bode magnitude for different zeta values. Part of the article RLC resonator.\(\)
Bandwidth and Q-factor
Oscillators with a high quality factor oscillate with a smaller range of frequencies and are therefore more stable. The quality factor is defined as the natural frequency \(\omega_n\) multiplied with the ratio of the maximum energy stored and the power loss. The maximum energy stored can be calculated from the maximum energy in the inductor or capacitor. The equation below uses the maximum energy in the inductor \(LI_{rms}^2\). At the natural frequency \(\omega_n\), the impedance of the capacitor and inductor cancel each other and power is only dissipated in the resistor \(RI_{rms}^2\).
The Q factor also relates the frequencies \(\omega_1\) and \(\omega_2\) where the dissipated power equals half the power stored. Consequently, the transfer function \(H(s)\) equals \(\frac{1}{\sqrt{2}}\) (-3dB) as shown in the illustration below
Power
The half power bandwidth BW follows from solving the equation \(H(s)=\frac{1}{\sqrt{2}}\)
The Q factor equals the ratio of resonant frequency \(\omega_n\) to half power bandwidth \(\omega_2-\omega_1\).
$$
Q = \frac{\omega_n}{\omega_2-\omega_1}=\frac{1}{R}\sqrt{\frac{L}{C}}
= \frac{1}{2\zeta}
\label{eq:qfactor2}
$$
High quality factor \(Q>1\) results in a sharp resonance peak.
Bode magnitude for different \(\zeta\)
Note that the frequency-dependent definition can be uses to describe circuits with a single capacitor or inductor, opposed to the frequency-to-bandwidth ratio definition.
Shows the frequency response of a RLC resonator in the overdamped, critically-damped and underdamped cases. Part of the article RLC resonator.
Frequency response
\(\)The dampening coefficient \(\zeta\) determines the behavior of the system. With the physical assumption that the value of \(\frac{1}{LC}\gt 0\) and \(\frac{R}{L}\geq0\), we can identify four classes of pole locations.
Effect of the dampening coefficient on system behavior
Condition
Pole location
ζ
Referred to as
\(R>2\sqrt\frac{L}{C}\)
different locations on the negative real axis
\(\zeta>1\)
overdamped
\(R=2\sqrt\frac{L}{C}\)
coincite on the negative real axis
\(\zeta=1\)
critically damped
\(R\lt 2\sqrt\frac{L}{C}\)
complex conjugate poles in the left half of the s-plane
\(\zeta\lt 1\)
underdamped
The remainder of this post will determine determine the frequency response for each of these classes.
Two Different Real Poles (overdamped case)
In the overdamped case the two poles are on separate locations on the negative real axis.
Note that \(p_1\lt p_2\lt 0\) and \(|p_1|\lt |p_2|\), as visualized in the s-plane
\(s\)-plane
The frequency response is the magnitude (or gain) as a function of the frequency. It describes how well the filter can distinguish between different frequency signals.
A cosinusoidal input signal \(u_i(t)\) with angular frequency \(\omega\), amplitude \(1\) and with the value 1 at \(t=0\), can be expressed as
Therefore, the frequency response may be written in terms of the system poles and zeros by substituting \(s=j\omega\) for \(s\) directly into the factored form of the transfer function
The poles and zero may be interpreted as vectors in the s-plane, originating from the zero or poles \(p_i\) and directed to the point \(s=j\omega\) at which the function is to be evaluated
Evaluated at \(j=s\omega\)
The transfer function can be expressed in polar form
The frequency response has -20 dB/decade drop-offs, and a relatively wide band-pass for \(|p_2|\lt \omega\lt |p_1|\).
Frequency response
Coinciting Real Poles (critically-damped case)
In the critically-dampened case the two poles coincite on the negative real axis.
$$
p = -\frac{R}{2L},\ R=2\sqrt\frac{L}{C}
$$
The poles and zero are on the left real axis \(p\lt 0\), as visualized in the s-plane
\(s\)-plane
The frequency response may be written in terms of the system poles and zeros by substituting \(j\omega\) for \(s\) directly into the factored form of the transfer function
The poles and zero may be interpreted as vectors in the s-plane, originating from the poles \(p\) or zero \(z=0\) and directed to the point \(s=j\omega\) at which the function is to be evaluated
Evaluated at \(s=j\omega\)
The transfer function can be expressed in polar form as
The poles and zero may be interpreted as vectors in the s-plane, originating from the poles (pi) and zero and directed to the point s=jω at which the function is to be evaluated
Evaluates at \(s=j\omega\)
The transfer function can be expressed in polar form as
The graph shows the magnitude of the output for different values of \(R\). Note that the voltage amplification around the natural frequency \(\omega_n\) . The magnitude of the frequency response has -20 dB/decade drop-offs, and a sharp resonance at \(|p|\).
We use cookies on our website to give you the most relevant experience by remembering your preferences and repeat visits. By clicking “Accept”, you consent to the use of ALL the cookies.
This website uses cookies to improve your experience while you navigate through the website. Out of these, the cookies that are categorized as necessary are stored on your browser as they are essential for the working of basic functionalities of the website. We also use third-party cookies that help us analyze and understand how you use this website. These cookies will be stored in your browser only with your consent. You also have the option to opt-out of these cookies. But opting out of some of these cookies may affect your browsing experience.
Necessary cookies are absolutely essential for the website to function properly. These cookies ensure basic functionalities and security features of the website, anonymously.
Cookie
Duration
Description
cookielawinfo-checkbox-analytics
11 months
This cookie is set by GDPR Cookie Consent plugin. The cookie is used to store the user consent for the cookies in the category "Analytics".
cookielawinfo-checkbox-functional
11 months
The cookie is set by GDPR cookie consent to record the user consent for the cookies in the category "Functional".
cookielawinfo-checkbox-necessary
11 months
This cookie is set by GDPR Cookie Consent plugin. The cookies is used to store the user consent for the cookies in the category "Necessary".
cookielawinfo-checkbox-others
11 months
This cookie is set by GDPR Cookie Consent plugin. The cookie is used to store the user consent for the cookies in the category "Other.
cookielawinfo-checkbox-performance
11 months
This cookie is set by GDPR Cookie Consent plugin. The cookie is used to store the user consent for the cookies in the category "Performance".
viewed_cookie_policy
11 months
The cookie is set by the GDPR Cookie Consent plugin and is used to store whether or not user has consented to the use of cookies. It does not store any personal data.
Functional cookies help to perform certain functionalities like sharing the content of the website on social media platforms, collect feedbacks, and other third-party features.
Performance cookies are used to understand and analyze the key performance indexes of the website which helps in delivering a better user experience for the visitors.
Analytical cookies are used to understand how visitors interact with the website. These cookies help provide information on metrics the number of visitors, bounce rate, traffic source, etc.
Advertisement cookies are used to provide visitors with relevant ads and marketing campaigns. These cookies track visitors across websites and collect information to provide customized ads.