MATLAB Workbook
CME104
Linear Algebra and Partial Differential Equations for Engineers
Authors
Jennifer Chien Perrine Pepiot Vadim Khayms
Linear Algebra and Applications
1. Matrices and Vectors
Commands : * size round : : : : Matrix multiplier operator Returns the size of a vector or matrix Matrix transpose operator Returns integer value(s) of the argument and . Determine the size of the resulting
Multiply two matrices
matrix. Display the bottom left-element and the second column on the screen.
! SOLUTION
clear
CODE from M-file
C(:,2) OUTPUT C= 5 5 2 3 3 1 -1
% Initialize matrices A=[1 2; -1 3]; B=[1 0 1; 2 1 0]; % Calculate and display product of matrices C=A*B % Calculate and display size of new matrix Csize = size(C) % Display bottom leftelement and second column C(2,1)
Csize = 2 ans = 5 ans = 2 3
" YOUR TURN
a) Find the dot product between the first and the second rows of matrix .
b) Compute c)
using the matrices ,
and , , and
. . Compute the
A rectangle is formed by the four vertices:
co-ordinates of each vertex after a rotation of 60 (or Plot the rectangle before and after the rotation.
rad ) using a rotation matrix R.
Hint :
Hint:
To plot any set of points linked together in MATLAB, create a matrix whose first line contains the x-components of each point and the second one, the ycomponents. Then plot the first line versus the second one. To close your rectangles, use the first vertex as first and last point.
d) Each year, a college accepts 1000 freshmen and 200 sophomores into the school. Also, 10% of the freshman, 25% of the sophomores, 5% of the juniors, and 5% of the seniors repeat their year. The rest continue their studies. If there are 1160 freshmen, 1057 sophomores, 1183 juniors, and 1028 seniors this year and the trend holds, what is the school population in 10 years? The system of equations to use is as follows:
where the number is indicative of the students year in college (1=freshman, 2=sophomore, etc). From the equations, we can derive an equation with
matrix
, and
Hint:
When displaying the final population vector, use the round function to display integral values. We cannot have partial students.
2. Gaussian Elimination
Commands : rank rref inv : : : Returns the rank of a matrix Returns the reduced echelon of a matrix Returns the inverse of a matrix
Find the rank and solution (if it exists) to the following system of equations:
using the reduced row echelon method, inverse method, and Gaussian elimination method.
! SOLUTION
clear
CODE from M-file
% Initialize matrix. See note below A = [0,7,3,-12;2,8,1,0;-5,2,-9,26];
Arank = % Calculate and display rank of matrix Arank = rank(A) % Calculate and display reduced row echelon form rref(A) % Calculate and display inverse method A = [0,7,3,; 2,8,1; -5,2,-9]; b = [-12;0;26]; x = inv(A)*b % Calculate and display Gaussian elimination x = A\b OUTPUT x= 2 0 -4 x= 2 0 -4 3 x= 1 0 0 0 1 0 0 0 1 2 0 -4
Note:
The function rref needs a matrix input in the form of . For the matrix that rref produces, the last column contains the solutions for the matrix. The first element is the solution for x, the second for y, and the last for z.
" YOUR TURN
battery is and the right. , (bottom loop).
A loop is set up like in the figure to the right. The potential of the . The resistors have values of , , . Find the currents of the network, depicted on The equations of the currents in this loop are (top loop), and
3. Least Squares
Commands : polyfit : Finds the coefficients of a polynomial to fit the data in a least squares sense.
Data from a current flowing across a capacitor is recorded. If the theoretical decrease in current is supposed to be linear, plot the graph that best represents the data: (1,0), (2,6), (3,5), (4,2), and (5,0).
! SOLUTION
clear close
CODE from M-file
p = polyfit(t,Idata,1); % Calculate range for best fit I = p(1)*t+p(2); % Plot raw data plot(t,Idata,'+') hold on % Plot linear fit plot(t,I)
% Initialize raw data t = [1,2,3,4,5]; Idata = [9,6,5,2,0]; % Calculate coefficients of polynomial
title('Least-Squares Fit, Linear Curve') xlabel('time, t') ylabel('Current, I') OUTPUT
Note:
The vector p contains the coefficients of a linear function. The 1 represents a polynomial to the 1st degree.
" YOUR TURN
In a laser experiment, current and laser power is collected in a test run. Find the best quadratic curve to fit the data.
Current (milliamps) Laser Power (microwatts)
0.1 0.000
0.2 0.000
0.3 0.001
0.4 0.002
0.5 0.018
0.6 0.056
0.7 0.115
0.8 0.201
0.9 0.301
1.0 0.523
Hint:
For a quadratic fit, find p such that
Eigenvalues and Eigenvectors
4. Eigenvalues and Eigenvectors
Commands : eig : Returns eigenvalues and eigenvectors
Two blocks of mass m are placed in-between three springs with constant k. A system of equations can be set up such that and . If and , and an initial displacement of the blocks are , and , find the equation of the position of the block as a function of time. Plot the displacement of the blocks as a function of time with for the first twenty seconds. Draw a picture of the mode shapes of the blocks. Note: The negative sign means that the block is displaced to the left.
! SOLUTION
clear close
CODE from M-file
-1
% Initialize constants and matrix m = 1; k = 1; A = [-2*k/m,k/m; k/m,-2*k/m]; % Calculate and display eigenvectors and eigenvalues [Q,d] = eig(A) % Calculate constant C x0 = [0.1;-0.3]; C = inv(Q)*x0; % Calculate and plot motion of blocks t = linspace(0,20,200); w=sqrt(-d); x = C(1)*Q(:,1)*cos(w(1,1)*t) + C(2)*Q(:,2)*cos(w(2,2)*t); plot(t,x) title('Displacement of blocks as a function of time') xlabel('Time') ylabel('Displacement') legend('x1','x2') OUTPUT Q= 0.7071 -0.7071 d= -3 0 0.7071 0.7071 Mode 2
Drawing of mode shapes Mode 1
" YOUR TURN
Three blocks of mass m are placed in-between four springs with constant k. A system of equations can be set up such that ,
, and
. If
and the initial displacement of the blocks are , , and , find the equation of the position of the block as a function of time. Plot the displacement of the blocks as a function of time with for the first thirty seconds. Draw a picture of the mode shapes of the blocks.
5. Power of Matrix
Given the matrix method. , calculate directly, and then using the diagonalization
! SOLUTION
clear
CODE from M-file OUTPUT A5_1 = 212 7564 A5_2 = 212 7564 17019 -9243 17019 -9243
% Initialize variables A = [2,9;4,-3]; % Direct computation and display answer A5_1 = A^5 % Diagonalization [Q,d] = eig(A); % Display answer A5_2 = Q*d^5*inv(Q)
" YOUR TURN
Suppose each year, 5% of the students at UC Berkeley transfer to Stanford and 1% of the students at Stanford transfer to Berkeley. Determine the population after 5 years if there were initially 50,000 students in Berkeley and 10,000 students in Stanford. The transformation matrix to use is .
Note:
x1 is the Stanford population and x2 is the Berkeley population.
Fourier Series
6. Fourier Series
For the function , the odd Fourier expansion is given by . Plot the actual function and first 3 partial sums over the domain , all on the same set of axes. Observe how the Fourier series is accurate over many periods.
! SOLUTION
clear close
CODE from M-file
% Maximum iteration for the fourier series nmax = 5; % Domain of plot x = linspace(-2*pi,2*pi,1000); % Plot of function f(x) for i = 1:length(x) if x(i) <= -pi | (x(i) > 0 & x(i) <= pi) f(i) = 1; end if (x(i) > -pi & x(i) <= 0) | x(i) > pi f(i) = -1; end end plot(x,f) hold on % Calculate and plot first 3 partial sums A0 = 0; y = A0; for n=1:2:nmax
An = 0; Bn = 4/(n*pi); y = y + An*cos(n*x) + Bn*sin(n*x); plot(x,y) hold on end xlabel('x') ylabel('y') legend('f','n = 1','n = 3','n = 5') OUTPUT
" YOUR TURN
For the function , , given the Fourier expansion , plot the actual function and first 5 partial sums, all on the same set of axes.
7. Forced Vibrations
Commands : stem : plots a graph of discrete points
Forced oscillations of a body of mass m on a spring of modulus k are governed by the equation: (1) with displacement of the mass from rest damping constant external force depending on time applied to the mass-spring system Using gm/sec, gm/sec!, gm and the following external force:
and
a) Solve equation (1) using Fourier series b) Plot : - the forcing function - the displacement of the mass - the contribution of each frequency component to the final solution. What is the relation between the two last plots?
! SOLUTION
a) The Fourier series of the external force is : differential equation is then : solution of the form: Fourier coefficients: . The . Assuming a , we obtain the following and . The contribution of each frequency component to the final solution is given by
CODE from M-file clear close all % Parameters of the system m = 0.05; % Mass k = 40; % Stiffness L =0.02; % Damping constant % Time t = -5:0.01:5; % Initialization f = zeros(1,length(t)); External force y = zeros(1,length(t)); Displacement of the mass % % C = zeros(100,1); of each frequency for n = 1:2:100 f = f-4/(n*pi)^2*cos(n*pi*t); An = 4/(n*pi)^2*(m*n^2*pi^2k)/((m*n^2*pi^2-k)^2+(L*n*pi)^2); Bn = An*(L*n*pi)/(m*n^2*pi^2-k); C(n) = sqrt(An^2+Bn^2); y = y + An * cos(n*pi*t) + Bn * sin(n*pi*t); end % Amplitude
% Plot of the discrete amplitude of each frequency stem(C) title('Contribution of each frequency to the displacement of the mass') xlabel('Frequency') ylabel('Amplitude') grid on % Plot of the external force applied to the system figure plot(t,f) title('External force applied to the system') xlabel('Time') ylabel('Amplitude') grid on % Plot of the displacement of the mass figure plot(t,y) title('Displacement of the mass') xlabel('Time') ylabel('Amplitude') grid on
OUTPUT
We see on the last plot that 2 frequencies have larger contributions to the final response. These two frequencies appear clearly on the plot of the displacement : the signal is composed of a low frequency upon which a higher frequency is superposed.
" YOUR TURN
Youre in your car driving on a rough road. Suppose that the shape of the road is given by the equation :
The mass of the car is
Newtons law applied to the point above the suspension gives:
with
displacement of the point A shape of the road
which can be re-written as Assuming the solution of the form following Fourier series representation for y : , we obtain the
with
and
and
a) Using the equations above, write a code which computes the displacement of point A. Test your code with the following cases: ,
Case 1 2 3 4 5
Stiffness k 104 m/sec! 105 m/sec! 106 m/sec! 105 m/sec! 105 m/sec!
Damping Constant c 100m/sec 100m/sec 100m/sec 10m/sec 1000m/sec
In each case, plot the vertical displacement as a function of time for t between 0 and 4T and the contribution of each frequency to the displacement using the stem command. b) What are the effects of k and c on the displacement of point A?
Using the Diffusion Equation
8. 1D Heat Conduction Equation
The temperature of the ends of a rod, length 3, is heated such that . The ends of the rod are then connected to insulators to maintain the ends at , with , is: and . The solution to the heat conduction equation and
. Plot the temperature distribution of the rod at t = 0, 0.1, 1, 3, and 10.
! SOLUTION
clear close
CODE from M-file
% Set maximum number of partial sums nmax = 11; % Initialize domain x = linspace(0,3,1000); % Plot initial condition for i = 1:length(x) if x(i) <= x(length(x))/2 T(i) = x(i); else T(i) = 3-x(i); end end plot(x,T) hold on % Calculate temperature of rod at various times t=[0.1,1,3,10]; for k = 1:4 T = 0; for n=1:4:nmax Bn = 4/(n^2*pi^2); T =T+ Bn*sin(n*pi*x/3)*exp(n^2*pi^2*t(k)/9);
end for n = 3:4:nmax Bn = -4/(n^2*pi^2); T =T+ Bn*sin(n*pi*x/3)*exp(n^2*pi^2*t(k)/9); end plot(x,T) end legend('t=0','t=0.1','t=1','t=3','t=10') xlabel('Length along rod, x') ylabel('Temperature, C') OUTPUT
" YOUR TURN
A rod of length 2 has the following initial and boundary temperature conditions: , , and . The solution to the heat equation with is . Plot the
temperature distribution of the rod at t = 0, 0.05, 0.1, and 0.5.
9. 2D Laplace Equation
A rectangular plate is bounded by boundary conditions: , , , , , and , and with the following . The steady-
state temperature distribution is governed by
. The solution is . Plot this temperature distribution.
! SOLUTION
clear close
CODE from M-file
colorbar colormap gray title('Steady-State Temperature Plot') OUTPUT
% Initialize square grid [x,y] = meshgrid(0:0.01:1,0:0.01:1); % Set maximum number of partial sums nmax = 9; % Initialize T T = zeros(length(x),length(y)); % Calculate steady state temperature distribution for n = 1:2:nmax T = T + 400/pi .* sinh(n*pi*y)/(n*sinh(n*pi)) .* sin(n*pi*x); end % Plot temperature distribution surface(x,y,T) shading('interp')
" YOUR TURN
, and
A rectangular plate that is insulated on its two sides and is bounded by . The temperatures at the boundaries are , and ,
, ,
. The steady-state temperature distribution
governed by
. The solution is . Plot this temperature distribution.
10. Wave motion
A string of length 4 is fixed at the two end points such that string is displaced and released from its equilibrium position such that and solution is the displacement of the string in the first 3 seconds. . Given that the differential equation is , with , the . At , the ,
. Make a movie of
! SOLUTION
clear
CODE from M-file
ylabel('Displacement') % Record movie k = 1; set(h,'XData',x,'YData',u) M(k) = getframe; for k = 2:nframes t = (k-1)*dt; u = 0; for n = 1:2:nmax u=u+ (128/(n^3*pi^3)*cos(c*n*pi*t/4) + 32/(c*n^2*pi^2)*sin(c*n*pi*t/4))*sin (n*pi*x/4); end set(h,'XData',x,'YData',u) M(k) = getframe; end % Play movie movie(M,1,fps)
% Initialize constants and variables dt = 0.1; tmax = 30; nmax = 9; c = 1; nframes = tmax/dt; fps = nframes/tmax; % Initialize first picture at t = 0 x = linspace(0,4,100); u = 4 - (x-2).^2; h = plot(x,u); set(h); axis([0,4,-5,5]) grid off title('Movie of Oscilating String') xlabel('Length along string')
" YOUR TURN
A square membrane bounded by
, and
is fixed at the , .
boundaries and governed by the differential equation is At
, the membrane is displaced and released from its equilibrium position such that , and . Make a movie of the displacement of .
the membrane as a function of time
Note: For the set function, you should add a new argument for the third dimension. The new function will look like this: set(h,XData,x,YData,y,Zdata,u)
Boundary Value Problems
11. 1D Boundary Value Problem
A string of length L = 1m is fixed at both ends, such that the string is governed by the wave equation the form by , we obtain: , with . The motion of . Assume a solution of
. Substituting this solution into the wave equation and dividing
with a)
a constant.
Using a central difference scheme, discretize the differential equation for F. Set up a matrix equation for F of the form .
b) Determine and plot the first three mode shapes of the string first using 10 nodes, then using 100 nodes. Whats the value of k for each mode? What does it correspond to?
! SOLUTION
a) The differential equation for x is central difference: . It can be discretized using
In matrix notation, using the fact that both boundary conditions are 0:
of the form
which corresponds to an eigenvalue problem. b) The eigenvalues and eigenvectors of matrix A are obtained using MATLAB and the eig command.
CODE from M-file clear close % Boundaries a = 0; b = 1; % Number of points N = 10; % Location of the points x = linspace(a,b,N); % Distance between 2 points h = (b-a)/(N-1);
% Creation of matrix A A = zeros(N-2,N-2); A(1,1) = -2/h^2; A(1,2) = 1/h^2; for n = 2:N-3 A(n,n-1) = 1/h^2; A(n,n) = -2/h^2; A(n,n+1) = 1/h^2; end A(N-2,N-2) = -2/h^2; A(N-2,N-3) = 1/h^2; % Computation of the eigenvalues and eigenvectors [V,d]=eig(A); % Mode shapes plot(x,[0;V(:,N-2);0],'-') hold on plot(x,[0;V(:,N-3);0],'--') plot(x,[0;V(:,N-4);0],':') legend('First mode','Second mode','Third mode') title('First mode shapes of the string') xlabel('x') ylabel('Amplitude') grid on OUTPUT N = 10 nodes N = 100 nodes
MATLAB returns the eigenvalues sorted by increasing value, and in this case, they are all negative. What we call first modes corresponds to the smallest eigenvalues in magnitude. They correspond to the last columns of the matrix giving the eigenvectors. The eigenvalues are . For the first three modes, we have :
N = 10 nodes
N = 100 nodes
These results have to be compared to the theoretical values :
k represents the angular frequency in radian per second with which the modes oscillate in space. The more points there are, the closest from the theoretical results the numerical values are.
" YOUR TURN
.
The same kind of matrix is used to solve for example the 1D steady heat equation :
A rod of length is maintained at at ( ). This rod is heated uniformly with a source with the following boundary conditions : Assume a) .
and is insulated at the other end . and
Discretize the heat equation using a central difference scheme. Use the off-centred difference scheme to enforce the zero-gradient boundary condition at . Set up the matrix equation of the form .
b) Solve this matrix equation using the inv command. Use 100 points. Plot the temperature T as a function of x. Add labels and a title. c) Find the analytical solution and plot it on the same figure.
12. 2D Laplace Equation using Jacobi and Gauss-Seidel
A square cooling plate of length 1 is maintained at 0C. When the machine turns on, two sides are heated to 100C, as shown in the figure to the right. Using 10 nodes and 30 nodes, use the Jacobi iteration method to plot the steady-state temperature after the machine turns on, to within a 1% error. The iteration scheme is .
! SOLUTION
clear close
CODE from M-file for 10 nodes
% Initialize number of nodes M = 10; N = 10; % Initialize function u = zeros(M,N); % Initialize boundary conditions u(M,:) = 100; u(:,N) = 100; % Calculate temperature distribution flag = 1; while flag == 1 flag = 0; uold = u; for i = 2:M-1 for j = 2:N-1
u(i,j) = (uold(i-1,j) + uold(i+1,j) + uold(i,j-1) + uold(i,j+1))/4; error = abs((u(i,j)uold(i,j))/uold(i,j)); if error > 0.01 flag = 1; end end end end % Plot temperature distribution [x,y] = meshgrid(0:1/(M-1):1 , 0:1/(N-1):1); surface(x,y,u) colorbar colormap gray title('Square Plate, Jacobi Method, 10 nodes') xlabel('x') ylabel('y')
CODE from M-file for 30 nodes % same code with 30 nodes instead of 10 OUTPUT
Note:
The shading function was not used in this instance, so that the node distribution can be seen. If you use the shading function, the two plots will look the same.
" YOUR TURN
Using the same criteria as the example problem, adjust the code for the Gauss-Seidel iteration method using 30 nodes. The iteration scheme is . Note: The difference in efficiency may not be noticeable, but the Gauss-Seidel method will help the calculations reach the steady-state solution faster than with the Jacobi iteration.
13. Time-dependent heat equation
Heat generated from an electric wire is defined by the time-dependent heat equation: with Use the discretization scheme , . The analytical solution for this problem through Fourier series is : , and , and . with ,
to find the temperature distribution at t = 0, 0.01, 0.05, 0.1, 1. Take
Plot the analytical solution at the same time steps using the first ten partial sums, and compare the two graphs.
! SOLUTION
CODE from M-file clear close all % Initialize number of nodes and constants N = 10;
lambda = 1; L = 1; q = 1; h = L/(N-1); dt = 0.005; % Initialize domain x = linspace(0,L,N); % Initialize and plot heat distribution at t = 0 u = zeros(1,N); plot(x,u,'k') hold on % Calculate heat at specified times t = [0.02,0.05,0.1,1]; jmax = t/dt; k = 1; u = zeros(1,N); for j = 1:jmax(4) uold = u; for i=2:N-1 u(i) = uold(i) + lambda^2*dt/h^2*(uold(i-1)2*uold(i)+uold(i+1)) + q*dt; end if j == jmax(k) plot(x,u) k = k+1; end end % Calculate with analytical solution nmax = 19; L = 1; q = 1; x = linspace(0,L,1000); % Calculate and plot analytical temperature distribution at times, t
T = zeros(1000,1); plot(x,T,'r') hold on t = [0.02,0.05,0.1,1]; for k = 1:length(t) T = -q*x.^2/2 + q*L*x/2; for n = 1:2:nmax T = T - 4*L^2*q/(n^3*pi^3) * sin(n*pi*x/L) * exp(n^2*pi^2*t(k)/L^2); end plot(x,T,'r') end title('Time-dependent Heat Equation - Numerical and Analytical Solution') xlabel('Length along bar') ylabel('Temperature along bar') legend('t = 0','t = 0.02','t = 0.05','t = 0.1','t = 1') grid on OUTPUT
" YOUR TURN
A rod of length 1, whose initial temperature profile is , becomes attached on one end to a cooling reservoir, maintained at 0C while the other end is insulated, which gives the following boundary condition : .
For the time-dependent heat equation, , the iteration scheme is :
, for the rod using 30 nodes with
and insulated end. Plot the temperature profile of the rod at t = 0, 0.01, 0.05, 0.2, 0.5. Take
at the
14. Time-dependent heat equation Implicit Scheme
Heat generated from an electric wire is defined by the time-dependent heat equation: with Use the fully implicit discretization scheme with , and , , . and , and plot
the temperature distribution at t = 0, 0.01, 0.05, 0.1, 1. Take
Note:
The fully implicit distribution scheme is
! SOLUTION
clear close
CODE from M-file
% Initialize number of nodes and constants N = 10; L = 1; lambda = 1; h = L/(N-1); q = 1; dt = 0.01; % Initialize A r = lambda^2*dt/(h^2); A = zeros(N-2,N-2); A(1,1) = 1+2*r; A(1,2) = -r; for i=2:N-3 A(i,i-1) = -r; A(i,i) = 1+2*r; A(i,i+1) = -r; end A(N-2,N-3) = -r; A(N-2,N-2) = 1+2*r; % Initialize b b = zeros(N-2,1); for i = 1:N-2 b(i,1) = q*dt; end % Initialize domain x = linspace(0,L,N)'; % Initilize u at t = 0 u = zeros(N,1); plot(x,u,'k') hold on
% Calculate and plot temperature distribution at times, t t = [0.01,0.05,0.1 1]; jmax = t/dt; k = 1; for j = 1:jmax(4) u(2:N-1) = inv(A)*(u(2:N-1)+b); if j == jmax(k) plot(x,u,'k') k = k+1; end end title('Time-dependent heat equation, implicit') xlabel('Length along rod') ylabel('Temperature') legend('t = 0','t = 0.01','t = 0.05','t = 0.5','t = 1') grid on OUTPUT
" YOUR TURN
A rod of length 1, whose initial temperature profile is , becomes attached on one end to a cooling reservoir, maintained at 0C the other end is insulated, which gives the following boundary condition : .
For the time-dependent heat equation,
, using 30 nodes with
, use the
fully-implicit iteration scheme to plot the temperature profile of the rod at t = 0, 0.01, 0.05, 0.2, 0.5. Take