Numerical Methods Applied to Chemical Engineering Homework #3. Nonlinear algebraic equations and matrix eigenvalue problems SOLUTION

Size: px
Start display at page:

Download "Numerical Methods Applied to Chemical Engineering Homework #3. Nonlinear algebraic equations and matrix eigenvalue problems SOLUTION"

Transcription

1 0.34. Numerical Methods pplied to Chemical Engineering Homework #3. Nonlinear algebraic equations and matrix eigenalue problems SOLUTION Problem. Modeling chemical reaction with diffusion in a catalyst pellet In HW #, we considered the use of the finite difference method to conert a boundary alue problem into a set of linear algebraic equations. In HW #, we considered the use of Newton s method to sole sets of nonlinear algebraic equations. In this problem, we combine these two approaches to sole a boundary alue problem that contains a nonlinear term inoling chemical reaction. This problem is inspired by the discussion of nonisothermal catalyst particles in section 3.9 of G. F. Froment and K. B. Bischoff, Chemical Reactor nalysis and Design, nd ed., Wiley, 990. We consider the case of a spherical catalyst pellet of radius R (see figure below). We want to write a MTLB program that will employ a finite difference method to sole for the dimensionless concentration profile and the effectieness factor. The goerning equation in dimensionless form is d dψ γβ( Ψ) ξ ξ Φ exp Ψ = 0 (EQ 56) dξ dξ + β( Ψ) subect to the boundary conditions dψ Ψ () = = 0 (EQ 57) d ξ ξ= 0 where Ψ is the dimensionless concentration inside the catalyst pellet and ξ is the dimensionless radius of the particle. The program should take three input parameters: Φ, γ, and β, which are defined in EQ (50), (5), and (54) of the assignment sheet, respectiely.

2 We are going to sole this problem using finite differences. Let s number the grid points in the following way: ξ = 0 ξ = 0 N- N N+ Discretizing the second deriatie in (EQ 56) using central finite differences d d ξ Ψ Ψ ξ d dξ dξ ξ+ / ξ / where + / / d dξ dξ Ψ ξ + / ξ / ξ = = ξ = ξ Ψ Ψ Ψ Ψ ξ ξ ξ, +,,, + / / ξ+ ξ ξξ + / / * =, Ψ, +, Ψ, +, + Ψ, + (EQ 7 ),,, + ξ / = ( ξ ξ )( ξ+ / ξ /) ξ / ξ + / = + ξ+ / ξ / ξ+ ξ ξ ξ ξ + / = ( ξ+ ξ)( ξ+ /ξ/) The nonlinear algebraic equation for an interior grid point, [, N], takes the form γβ( Ψ, ) *, Ψ, +, Ψ, +, + Ψ, + ξ Φ exp Ψ, = 0 (EQ 8 ) + β( Ψ, ) s described on page 5 of the assignment sheet, some modification of the aboe equation is required for the first and last grid points. t the last grid point, = N, the discretized form of the differential equation is γβ( Ψ, ) N * N, N Ψ N, + N, NΨ N, + N, N+ ΨN, + ξnφ exp Ψ N, = 0 (EQ 30 ) + β( ΨN, ) where Ψ, = Ψ = from the boundary condition. N+ ξ=

3 The modification for grid point = is slightly more inoled and is described in detail on pp. 6-7 of the assignment sheet. Using the second boundary condition, we arried at the relation 4Ψ Ψ =,0 Ψ (EQ 4 ),, * 3 and the algebraic equation therefore became 4 γβ( Ψ,) *, +,0 Ψ, +,,0 Ψ, ξ Φ exp Ψ, = 0 (EQ 43 ) β( Ψ,) s was mentioned in the hints for this assignment, the fsole() routine is executed much faster if the Jacobian matrix is calculated analytically and supplied to the subroutine. The general form of the Jacobian is df dx df dx df dx N df dx df dx df dx N Jac = dfn dx dfn dx dfn dx N In our case, [f.f N ] will be expressions in (EQ 8 * ), (EQ 30 * ), and (EQ 43 * ) and [x.x N ] are [Ψ,.Ψ,N ]. Gien that these three equations are at most functions of three different Ψ,, the Jacobian matrix will hae at most three non-zero entries in each row. For completeness, let s find the entries of the Jacobian for an interior point. df Jac(, ) = = dψ, df Jac(, + ) = = dψ, +,, + df d γβ( Ψ ) Jac(, ) = = ξ Φ exp Ψ dψ Ψ + ( Ψ ) dθ =, ξ Φ Θ+ Ψ, dψ, where Θ =,,,, d, β, γβ( ) Ψ + β( Ψ, ), exp and therefore 3

4 dθ ( γβ) γβ ( Ψ, ) = Θ + dψ, + β( Ψ, ) + β( Ψ, ) t this point, we are ready to code in the problem in order to calculate the concentration profile. Once that is done, this profile can be used to calculate the effectieness factor from (EQ 6) using the trapz() function. The first of the attached plots is a concentration profile for a particular set of input parameters, and the second plot is the master plot required by Question.. 4

5 % PROBLEM CODE % catalyst_nonisothermal_scan_.m % % This MTLB program plots the effectieness % factor s. the Thiele modulus for a catalyst % pellet with first order reaction at steady % state in nonisothermal operation. % No external mass or heat transfer resistance % is included, and Diriclet boundary conditions % are employed at the particle surface. % % To sole the dimensionless PDE's, finite % differences are used with a non-uniform % grid (except near r=0 for discretized % symmetry boundary condition). % % The dimensionless input parameters are : % Phi_TM = Thiele modulus % = product of particle radius and % the square root of the rate % constant diided by the diffusiity % = measure of importance of diffusion % limitations % gamma = actiation energy / (R*Ts), where % Ts is the known surface temperature % beta = Da*(-DH)*Cs/lambda/Ts, where Da is % the diffusiity, DH is the heat of % reaction, Cs is the known surface % concentration, lambda is the thermal % conductiity, and Ts is the known % surface temperature % = measure of importance of heat generation % by reaction s. thermal conductiity % % Written K. Beers. MIT ChE. 9//00 %. 9//00. modified from catalyst_nonisothermal_scan_.m % to compute the Jacobian analystically, saing % time required to perform finite differences % % COMPRISON : beta = 0, gamma = 0, % phi_tm_min = e-, phi_tm_max = e, % num_tm = 0, dz = 0.0, dz_fine = 0.00 % catalyst_nonisothermal_scan.m: CPU =.56 % catalyst_nonisothermal_scan_.m: CPU =.6 % (BUT HD WRNINGS SINCE USED SPRSE % JCOBIN, STILL WORKS) function iflag_main = catalyst_nonisothermal_scan() cpu_start = cputime; iflag_main = 0; % First, hae the user input the simulation parameters. %disp('enter simulation parameters,...'); 5

6 % problem parameters %beta = input('enter beta (row ector) : '); beta = [-0.;-0.;0;0.05] num_beta = length(beta); gamma = input('enter gamma : '); % Thiele modulus bounds (log scale) phi_tm_min = input('enter min. Thiele modulus : '); phi_tm_max = input('enter max. Thiele modulus : '); num_tm = input('enter number of Thiele modulus points : '); phi_tm = logspace(log0(phi_tm_min),log0(phi_tm_max),num_tm); % number of physical grid points, use simple uniform scale with fine grid near surface dz = input('enter interior grid point spacing : '); dz_fine = input('enter surface (0.9-.0) spacing : '); z_grid = [ [dz : dz : 0.9-dz], [0.9 : dz_fine :.0-dz_fine] ]; num_grid = length(z_grid); % We now scan the alues of the Thiele modulus, starting at the lowest alue. For each alue of % the Thiele modulus, we need to sole the set of nonlinear algebraic equations obtained by finite % difference disrectization of the goerning equations. We start at the lowest alue of the Thiele % modulus, and use as an initial guess a completely uniform concentation profile. In the limit of % the Thiele modulus goes to zero, this initial guess is correct. For each subsequent calculations, % we use the final result of the last calculation as an initial guess. % allocate space to store the effectieness factor eta_eff = zeros(num_beta,num_tm); figure; for k_beta = :num_beta; % form initial guess - uniform concentration psi_guess = ones(size(z_grid)); % set some options flags for fsole() options = optimset('tolfun',e-8, 'Display','off', 'LargeScale','off',... 'Jacobian','on'); % iterate oer each alue of the Thiele modulus do_plot = 0; for i_tm = :num_tm % compute dimensionless profile [psi,fal,exiflag] =... fsole(@catalyst_nonisothermal_calc_f,... psi_guess, options,... phi_tm(i_tm), beta(k_beta), gamma, z_grid); if(do_plot) figure; plot(z_grid,psi); xlabel('\zeta (dimensionless radius)'); ylabel('\psi (dimensionless conc.)'); title('nonisothermal catalyst pellet'); end 6

7 % compute effectieness factor eta_eff(k_beta,i_tm) = calc_eta_eff(psi,... phi_tm(i_tm), beta(k_beta), gamma, z_grid) % disp(['eta = ' intstr(eta_eff(k_beta,i_tm))]); end % Now, plot out the results semilogx(phi_tm,eta_eff); %gtext(numstr(beta(k_beta))); hold on; end legend('\beta = -0.','\beta = -0.','\beta = 0','\beta = 0.05') xlabel('\phi (Thiele modulus)'); ylabel('\eta (effectieness factor)'); title(['nonisothermal catalyst: ', '\gamma = ', numstr(gamma), ' \beta aried']); iflag_main = ; cpu_end = cputime; cpu_elapsed = cpu_end - cpu_start; disp(['elapsed CPU time : ', numstr(cpu_elapsed)]); return; % ========================================================= % This routines calculates the function alues for the % set of equations that sole for the dimensionless % concentration profile within the catalyst pellet % for a nonisothermal first order reaction. % K. Beers. MIT ChE. 9//00 function [fal,jac] = catalyst_nonisothermal_calc_f(psi,... phi_tm, beta, gamma, z_grid); num_grid = length(z_grid); % allocate space for function ector % and Jacobian fal = zeros(size(psi)); Jac = spalloc(num_grid,num_grid,3*num_grid); % For each point except the first and last, compute % the alue of the function. for =:(num_grid-) % estimate the local second deriatie in % spherical coordinates z_mid_up = (z_grid(+)+z_grid())/; z_mid_lo = (z_grid()+z_grid(-))/; dz_mid = z_mid_up - z_mid_lo; dz_up = z_grid(+) - z_grid(); 7

8 end dz_lo = z_grid() - z_grid(-); _lo = (z_mid_lo^)/(dz_lo*dz_mid); _mid = (-/dz_mid)*((z_mid_up^)/dz_up + (z_mid_lo^)/dz_lo); _up = (z_mid_up^)/(dz_up*dz_mid); second_deri = _lo*psi(-) + _mid*psi() +_up*psi(+); % compute nonlinear reaction term theta = exp( gamma*beta*(-psi()) / ( + beta*(-psi()))); rxn = (z_grid()^)*(phi_tm^)*theta*psi(); % compute function alue fal() = second_deri - rxn; % compute Jacobian elements Jac(,-) = _lo; Jac(,+) = _up; dtheta_dpsi = theta* (... (-gamma*beta)/(+beta*(-psi())) +... (gamma*beta^*(-psi()))/((+beta*(-psi()))^)); drxn_dpsi = (z_grid()^)*(phi_tm^) * (theta + psi()*dtheta_dpsi); Jac(,) = _mid - drxn_dpsi; % Now, calculate function alue for last point, employing known concentration at the % catalyst surface. z_mid_up = (+z_grid(num_grid))/; z_mid_lo = (z_grid(num_grid) +... z_grid(num_grid-))/; dz_mid = z_mid_up - z_mid_lo; dz_up = - z_grid(num_grid); dz_lo = z_grid(num_grid) - z_grid(num_grid-); _lo = (z_mid_lo^)/(dz_lo*dz_mid); _mid = (-/dz_mid)*((z_mid_up^)/dz_up +... (z_mid_lo^)/dz_lo); _up = (z_mid_up^)/(dz_up*dz_mid); second_deri = _lo*psi(num_grid-) +... _mid*psi(num_grid) + _up; % compute nonlinear reaction term theta = exp( gamma*beta*(-psi(num_grid)) /... ( + beta*(-psi(num_grid)))); rxn = (z_grid(num_grid)^)*(phi_tm^)*theta*psi(num_grid); % compute function alue fal(num_grid) = second_deri - rxn; % compute Jacobian elements = num_grid; Jac(,-) = _lo; dtheta_dpsi = theta* (... (-gamma*beta)/(+beta*(-psi())) +... (gamma*beta^*(-psi()))/((+beta*(-psi()))^)); drxn_dpsi = (z_grid()^)*(phi_tm^) *... (theta + psi()*dtheta_dpsi); Jac(,) = _mid - drxn_dpsi; 8

9 % Then, calculate function alue for % first point, using symmetry boundary % condition. z_mid_up = (z_grid()+z_grid())/; z_mid_lo = (z_grid())/; dz_mid = z_mid_up - z_mid_lo; dz_up = z_grid() - z_grid(); dz_lo = z_grid(); _lo = (z_mid_lo^)/(dz_lo*dz_mid); _mid = (-/dz_mid)*((z_mid_up^)/dz_up +... (z_mid_lo^)/dz_lo); _up = (z_mid_up^)/(dz_up*dz_mid); second_deri = (_mid+4*_lo/3)*psi() +... (_up - _lo/3)*psi(); % compute nonlinear reaction term theta = exp( gamma*beta*(-psi()) /... ( + beta*(-psi()))); rxn = (z_grid()^)*(phi_tm^)*theta*psi(); % compute function alue fal() = second_deri - rxn; % compute Jacobian elements = ; Jac(,+) = _up - _lo/3; dtheta_dpsi = theta* (... (-gamma*beta)/(+beta*(-psi())) +... (gamma*beta^*(-psi()))/((+beta*(-psi()))^)); drxn_dpsi = (z_grid()^)*(phi_tm^) *... (theta + psi()*dtheta_dpsi); Jac(,) = _mid + 4*_lo/3; - drxn_dpsi; return; % ======================================================= % This routine computes the effectieness factor from % the dimensionless concentration profile for a % catalyst particle with a nonisothermal first order % reaction. % K. Beers. MIT ChE. 9//00 function eta_eff = calc_eta_eff(psi,... phi_tm, beta, gamma, z_grid); % compute the augmented z grid including the end % points z_aug = [0, z_grid, ]; psi_aug = [0, psi, ]; psi_aug() = (4*psi()-psi())/3; % Now, compute on this augmented grid the alues % of the integrand. integrand = zeros(size(psi_aug)); for =:length(integrand) ar = gamma*beta*(-psi_aug()) /... ( + beta*(-psi_aug())); integrand() = 3*psi_aug()*(z_aug()^)*exp(ar); 9

10 end % Use the trapezoid rule to estimate the alue of the % integral. eta_eff = trapz(z_aug,integrand) return; 0

11 Problem. Eigenalues of 3x3 matrices In this problem we are gien the following three 3x3 matrices: = 3 0 B= 3 4 C= Question.. Which of these matrices can you tell by inspection, without computation, must hae all eigenalues be real numbers? Since = T and C = C T, matrices and C will hae real eigenalues. Question.B. Using Gershogen s theorem, what are the bounds on the possible alues of the eigenalues of? Is it possible that any of the eigenalues of are negatie? From Eqn. (3..-9) of the class notes, r = + = 3 r = + = 3 r = + = Using Eqn. (3..-0), we can get the bounds on the three eigenalues. λ r λ 0 λ 4 λ r λ 3 λ 4 λ r λ 4 3 λ Based on the limits, we see that all of the eigenalues of will be positie. Question.C. Which of these matrices are normal? real matrix D is said to be normal if the following condition holds : DD T = D T D. s a special case, we see that a real, symmetric matrix has D T = D, so that it is obiously

12 normal. Haing said this, based on our answer to Q..., matrices and C are normal. What about matrix B? T BB = T BB= and Since the condition stated aboe does not hold, matrix B is NOT normal. Question.D. For eery matrix that you know has all real eigenalues, compute the eigenalues and the normalized (unit-length) eigenectors by hand. Show your calculations. Let s look at matrix first. To find the eigenalues, we need to derie a characteristic polynomial in λ s, which is done in the following way. λ det( λi) = 3 λ 0 = λ The characteristic polynomial is then ( λ)(3 λ)(4 λ) (4 λ) + ( )(0 + (3 λ)) = 0 Rearranging, we get 3 λ λ λ =0 Soling for the three eigenalues, we get λ =.06, λ =3.3473, and λ 3 =4.53. Let s put expression = λ, where is the eigenector corresponding to a particular eigenalue, in the equation form. 3 0 = λ

13 + = λ () = λ () + 4 = λ (3) = (4) 3 Equation (4) ensures that the eigenector has unit length. From (), = 3(4 λ) (5) dding () and (), we get = λ( + ) 3 3 4λ 3λ = 3 (6) Substituting (5) and (6) into (4), 4λ [ λ ] (4 ) + + = (7) 3 λ Soling for 3 from (7) / 4 λ (4 λ) (8) 3 = λ Thus, we use Eqns. (8), (5), and (6) to get expressions for the three components of the eigenector for a gien alue of λ. The results are: λ = = λ = = λ = = Now let s look at matrix C. λ 0 0 det( C λi) = 0 λ = 0 0 λ and the characteristic polynomial is 3

14 ( λ )( λ) = 0 λ =, λ =, and λ = = λ We can apply exactly the same methodology here as we did for matrix, but gien the simple structure of matrix C, it might be quicker to find eigenalues by inspection. For λ=, we can take =, and = 3 = 0. nother option for this repeated root is = 0 and = 3 = (/) 0.5 = For λ = -, we can choose = 0 and = (/) 0.5 = and 3 = -. In summary, λ = 0 = 0 λ = = λ = =

Fall Exam II. Wed. Nov. 9, 2005

Fall Exam II. Wed. Nov. 9, 2005 Fall 005 10.34 Eam II. Wed. Nov. 9 005 (SOLUTION) Read through the entire eam before beginning work and budget your time. You are researching drug eluting stents and wish to understand better how the drug

More information

Astrometric Errors Correlated Strongly Across Multiple SIRTF Images

Astrometric Errors Correlated Strongly Across Multiple SIRTF Images Astrometric Errors Correlated Strongly Across Multiple SIRTF Images John Fowler 28 March 23 The possibility exists that after pointing transfer has been performed for each BCD (i.e. a calibrated image

More information

EIGENVALUES AND EIGENVECTORS

EIGENVALUES AND EIGENVECTORS CHAPTER 6 EIGENVALUES AND EIGENVECTORS SECTION 6. INTRODUCTION TO EIGENVALUES In each of Problems we first list the characteristic polynomial p( λ) A λi of the gien matrix A and then the roots of p( λ

More information

different formulas, depending on whether or not the vector is in two dimensions or three dimensions.

different formulas, depending on whether or not the vector is in two dimensions or three dimensions. ectors The word ector comes from the Latin word ectus which means carried. It is best to think of a ector as the displacement from an initial point P to a terminal point Q. Such a ector is expressed as

More information

Differential Geometry of Surfaces

Differential Geometry of Surfaces Differential Geometry of urfaces Jordan mith and Carlo équin C Diision, UC Berkeley Introduction These are notes on differential geometry of surfaces ased on reading Greiner et al. n. d.. Differential

More information

Solution to 1-D consolidation of non-homogeneous soft clay *

Solution to 1-D consolidation of non-homogeneous soft clay * Xie et al. / J Zhejiang Uni SCI 25 6A(Suppl. I):29-34 29 Journal of Zhejiang Uniersity SCIENCE ISSN 19-395 http://www.zju.edu.cn/jzus E-mail: jzus@zju.edu.cn Solution to 1-D consolidation of non-homogeneous

More information

1 :: Mathematical notation

1 :: Mathematical notation 1 :: Mathematical notation x A means x is a member of the set A. A B means the set A is contained in the set B. {a 1,..., a n } means the set hose elements are a 1,..., a n. {x A : P } means the set of

More information

Magnetic Fields Part 3: Electromagnetic Induction

Magnetic Fields Part 3: Electromagnetic Induction Magnetic Fields Part 3: Electromagnetic Induction Last modified: 15/12/2017 Contents Links Electromagnetic Induction Induced EMF Induced Current Induction & Magnetic Flux Magnetic Flux Change in Flux Faraday

More information

Lecture #9: Harmonic Oscillator: Creation and Annihilation Operators

Lecture #9: Harmonic Oscillator: Creation and Annihilation Operators 5.61 Fall, 013 Lecture #9 Page 1 Last time Lecture #9: Harmonic Oscillator: Creation and Annihilation Operators 1/ Simplified Schrödinger equation: ξ=α x, α =(kμ) 1/ n E +ξ ψ=0 (dimensionless) ξ nω reduced

More information

Notes on reaction-diffusion cases with effectiveness factors greater than one! Richard K. Herz,

Notes on reaction-diffusion cases with effectiveness factors greater than one! Richard K. Herz, Notes on reaction-diffusion cases with effectiveness factors greater than one! Richard K. Herz, rherz@ucsd.edu For isothermal n-th order reactions where n >= 0, the catalyst effectiveness factor value

More information

0 a 3 a 2 a 3 0 a 1 a 2 a 1 0

0 a 3 a 2 a 3 0 a 1 a 2 a 1 0 Chapter Flow kinematics Vector and tensor formulae This introductory section presents a brief account of different definitions of ector and tensor analysis that will be used in the following chapters.

More information

10.34 Numerical Methods Applied to Chemical Engineering Fall Homework #6: Boundary Value Problems (BVPs)

10.34 Numerical Methods Applied to Chemical Engineering Fall Homework #6: Boundary Value Problems (BVPs) 1.34 Numerical Methods Applied to Chemical Engineering Fall 15 Homework #6: Boundary Value Problems BVPs Problem 1. 1 points Most entropies of gas phase molecules tabulated in databases were not directly

More information

ES.1803 Topic 16 Notes Jeremy Orloff

ES.1803 Topic 16 Notes Jeremy Orloff ES803 Topic 6 Notes Jerem Orloff 6 Eigenalues, diagonalization, decoupling This note coers topics that will take us seeral classes to get through We will look almost eclusiel at 2 2 matrices These hae

More information

Chapter 2: 1D Kinematics Tuesday January 13th

Chapter 2: 1D Kinematics Tuesday January 13th Chapter : D Kinematics Tuesday January 3th Motion in a straight line (D Kinematics) Aerage elocity and aerage speed Instantaneous elocity and speed Acceleration Short summary Constant acceleration a special

More information

Min Chen Department of Mathematics Purdue University 150 N. University Street

Min Chen Department of Mathematics Purdue University 150 N. University Street EXISTENCE OF TRAVELING WAVE SOLUTIONS OF A HIGH-ORDER NONLINEAR ACOUSTIC WAVE EQUATION Min Chen Department of Mathematics Purdue Uniersity 150 N. Uniersity Street 47907-067 chen@math.purdue.edu Monica

More information

4-vectors. Chapter Definition of 4-vectors

4-vectors. Chapter Definition of 4-vectors Chapter 12 4-ectors Copyright 2004 by Daid Morin, morin@physics.harard.edu We now come to a ery powerful concept in relatiity, namely that of 4-ectors. Although it is possible to derie eerything in special

More information

Dynamics ( 동역학 ) Ch.2 Motion of Translating Bodies (2.1 & 2.2)

Dynamics ( 동역학 ) Ch.2 Motion of Translating Bodies (2.1 & 2.2) Dynamics ( 동역학 ) Ch. Motion of Translating Bodies (. &.) Motion of Translating Bodies This chapter is usually referred to as Kinematics of Particles. Particles: In dynamics, a particle is a body without

More information

MOTION OF FALLING OBJECTS WITH RESISTANCE

MOTION OF FALLING OBJECTS WITH RESISTANCE DOING PHYSICS WIH MALAB MECHANICS MOION OF FALLING OBJECS WIH RESISANCE Ian Cooper School of Physics, Uniersity of Sydney ian.cooper@sydney.edu.au DOWNLOAD DIRECORY FOR MALAB SCRIPS mec_fr_mg_b.m Computation

More information

Worksheet 9. Math 1B, GSI: Andrew Hanlon. 1 Ce 3t 1/3 1 = Ce 3t. 4 Ce 3t 1/ =

Worksheet 9. Math 1B, GSI: Andrew Hanlon. 1 Ce 3t 1/3 1 = Ce 3t. 4 Ce 3t 1/ = Worksheet 9 Math B, GSI: Andrew Hanlon. Show that for each of the following pairs of differential equations and functions that the function is a solution of a differential equation. (a) y 2 y + y 2 ; Ce

More information

Algorithms and Data Structures 2014 Exercises and Solutions Week 14

Algorithms and Data Structures 2014 Exercises and Solutions Week 14 lgorithms and ata tructures 0 xercises and s Week Linear programming. onsider the following linear program. maximize x y 0 x + y 7 x x 0 y 0 x + 3y Plot the feasible region and identify the optimal solution.

More information

Reaction/Diffusion at Electrode/Solution Interfaces: The EC 2 Reaction

Reaction/Diffusion at Electrode/Solution Interfaces: The EC 2 Reaction Int. J. Electrochem. Sci., 4(9) 1116-117 International Journal of ELECTROCHEMICAL SCIENCE www.electrochemsci.org Reaction/Diffusion at Electrode/Solution Interfaces: The EC Reaction Michael E G Lyons *

More information

Would you risk your live driving drunk? Intro

Would you risk your live driving drunk? Intro Martha Casquete Would you risk your lie driing drunk? Intro Motion Position and displacement Aerage elocity and aerage speed Instantaneous elocity and speed Acceleration Constant acceleration: A special

More information

10.34 Numerical Methods Applied to Chemical Engineering Fall Homework #4: IVP

10.34 Numerical Methods Applied to Chemical Engineering Fall Homework #4: IVP 10.34 Numerical Methods Applied to Chemical Engineering Fall 015 Homework #4: IVP Problem 1 (0 points). In this problem you will develop and implement an ODE solver for problems of the form dy = f(y) dt

More information

LESSON 4: INTEGRATION BY PARTS (I) MATH FALL 2018

LESSON 4: INTEGRATION BY PARTS (I) MATH FALL 2018 LESSON 4: INTEGRATION BY PARTS (I) MATH 6 FALL 8 ELLEN WELD. Integration by Parts We introduce another method for ealuating integrals called integration by parts. The key is the following : () u d = u

More information

To string together six theorems of physics by Pythagoras theorem

To string together six theorems of physics by Pythagoras theorem To string together six theorems of physics by Pythagoras theorem H. Y. Cui Department of Applied Physics Beijing Uniersity of Aeronautics and Astronautics Beijing, 00083, China ( May, 8, 2002 ) Abstract

More information

Blow up of Solutions for a System of Nonlinear Higher-order Kirchhoff-type Equations

Blow up of Solutions for a System of Nonlinear Higher-order Kirchhoff-type Equations Mathematics Statistics 6: 9-9, 04 DOI: 0.389/ms.04.00604 http://www.hrpub.org Blow up of Solutions for a System of Nonlinear Higher-order Kirchhoff-type Equations Erhan Pişkin Dicle Uniersity, Department

More information

Notes on Linear Minimum Mean Square Error Estimators

Notes on Linear Minimum Mean Square Error Estimators Notes on Linear Minimum Mean Square Error Estimators Ça gatay Candan January, 0 Abstract Some connections between linear minimum mean square error estimators, maximum output SNR filters and the least square

More information

A spectral Turán theorem

A spectral Turán theorem A spectral Turán theorem Fan Chung Abstract If all nonzero eigenalues of the (normalized) Laplacian of a graph G are close to, then G is t-turán in the sense that any subgraph of G containing no K t+ contains

More information

LINEAR ALGEBRA. and VECTOR GEOMETRY Volume 2 of 2 September 2014 edition

LINEAR ALGEBRA. and VECTOR GEOMETRY Volume 2 of 2 September 2014 edition LINEAR ALGEBRA and VECTOR GEOMETRY Volume 2 of 2 September 2014 edition Because the book is so large, the entire Linear Algebra course has been split into two olumes. Grant Skene for Grant s Tutoring (www.grantstutoring.com)

More information

UNDERSTAND MOTION IN ONE AND TWO DIMENSIONS

UNDERSTAND MOTION IN ONE AND TWO DIMENSIONS SUBAREA I. COMPETENCY 1.0 UNDERSTAND MOTION IN ONE AND TWO DIMENSIONS MECHANICS Skill 1.1 Calculating displacement, aerage elocity, instantaneous elocity, and acceleration in a gien frame of reference

More information

THE EFFECT OF LONGITUDINAL VIBRATION ON LAMINAR FORCED CONVECTION HEAT TRANSFER IN A HORIZONTAL TUBE

THE EFFECT OF LONGITUDINAL VIBRATION ON LAMINAR FORCED CONVECTION HEAT TRANSFER IN A HORIZONTAL TUBE mber 3 Volume 3 September 26 Manal H. AL-Hafidh Ali Mohsen Rishem Ass. Prof. /Uniersity of Baghdad Mechanical Engineer ABSTRACT The effect of longitudinal ibration on the laminar forced conection heat

More information

Reaction and Diffusion in a Porous Catalyst Pellet. by Richard K. Herz

Reaction and Diffusion in a Porous Catalyst Pellet. by Richard K. Herz Reaction and Diffusion in a Porous Catalyst Pellet by Richard K. Herz Solid catalysts are often called "heterogeneous catalysts" meaning that they are in a different phase from fluid reactants

More information

Section 6: PRISMATIC BEAMS. Beam Theory

Section 6: PRISMATIC BEAMS. Beam Theory Beam Theory There are two types of beam theory aailable to craft beam element formulations from. They are Bernoulli-Euler beam theory Timoshenko beam theory One learns the details of Bernoulli-Euler beam

More information

General Lorentz Boost Transformations, Acting on Some Important Physical Quantities

General Lorentz Boost Transformations, Acting on Some Important Physical Quantities General Lorentz Boost Transformations, Acting on Some Important Physical Quantities We are interested in transforming measurements made in a reference frame O into measurements of the same quantities as

More information

Cellular Metabolic Models

Cellular Metabolic Models Cellular Metabolic Models. Cellular metabolism. Modeling cellular metabolism. Flux balance model of yeast glycolysis 4. Kinetic model of yeast glycolysis Cellular Metabolic Models Cellular Metabolism Basic

More information

4. A Physical Model for an Electron with Angular Momentum. An Electron in a Bohr Orbit. The Quantum Magnet Resulting from Orbital Motion.

4. A Physical Model for an Electron with Angular Momentum. An Electron in a Bohr Orbit. The Quantum Magnet Resulting from Orbital Motion. 4. A Physical Model for an Electron with Angular Momentum. An Electron in a Bohr Orbit. The Quantum Magnet Resulting from Orbital Motion. We now hae deeloped a ector model that allows the ready isualization

More information

Validity of expressions

Validity of expressions E&M Lecture 8 Topics: (1)Validity of expressions ()Electrostatic energy (in a capacitor?) (3)Collection of point charges (4)Continuous charge distribution (5)Energy in terms of electric field (6)Energy

More information

FLUID FLOW AND HEAT TRANSFER IN A COLLAPSIBLE TUBE

FLUID FLOW AND HEAT TRANSFER IN A COLLAPSIBLE TUBE FLUID DYNAMICS FLUID FLOW AND HEAT TRANSFER IN A COLLAPSIBLE TUBE S. A. ODEJIDE 1, Y. A. S. AREGBESOLA 1, O. D. MAKINDE 1 Obafemi Awolowo Uniersity, Department of Mathematics, Faculty of Science, Ile-Ife,

More information

Chapter 11 Collision Theory

Chapter 11 Collision Theory Chapter Collision Theory Introduction. Center o Mass Reerence Frame Consider two particles o masses m and m interacting ia some orce. Figure. Center o Mass o a system o two interacting particles Choose

More information

ENGINEERING COUNCIL DYNAMICS OF MECHANICAL SYSTEMS D225 TUTORIAL 3 CENTRIPETAL FORCE

ENGINEERING COUNCIL DYNAMICS OF MECHANICAL SYSTEMS D225 TUTORIAL 3 CENTRIPETAL FORCE ENGINEERING COUNCIL DYNAMICS OF MECHANICAL SYSTEMS D5 TUTORIAL CENTRIPETAL FORCE This tutorial examines the relationship between inertia and acceleration. On completion of this tutorial you should be able

More information

Geostrophy & Thermal wind

Geostrophy & Thermal wind Lecture 10 Geostrophy & Thermal wind 10.1 f and β planes These are planes that are tangent to the earth (taken to be spherical) at a point of interest. The z ais is perpendicular to the plane (anti-parallel

More information

A Regularization Framework for Learning from Graph Data

A Regularization Framework for Learning from Graph Data A Regularization Framework for Learning from Graph Data Dengyong Zhou Max Planck Institute for Biological Cybernetics Spemannstr. 38, 7076 Tuebingen, Germany Bernhard Schölkopf Max Planck Institute for

More information

Physics Letters A. Existence of traveling wave solutions of a high-order nonlinear acoustic wave equation

Physics Letters A. Existence of traveling wave solutions of a high-order nonlinear acoustic wave equation Physics Letters A 373 009) 037 043 Contents lists aailable at ScienceDirect Physics Letters A www.elseier.com/locate/pla Existence of traeling wae solutions of a high-order nonlinear acoustic wae equation

More information

Review of Matrices and Vectors 1/45

Review of Matrices and Vectors 1/45 Reiew of Matrices and Vectors /45 /45 Definition of Vector: A collection of comple or real numbers, generally put in a column [ ] T "! Transpose + + + b a b a b b a a " " " b a b a Definition of Vector

More information

Lecture J. 10 Counting subgraphs Kirchhoff s Matrix-Tree Theorem.

Lecture J. 10 Counting subgraphs Kirchhoff s Matrix-Tree Theorem. Lecture J jacques@ucsd.edu Notation: Let [n] [n] := [n] 2. A weighted digraph is a function W : [n] 2 R. An arborescence is, loosely speaking, a digraph which consists in orienting eery edge of a rooted

More information

r t t x t y t z t, y t are zero, then construct a table for all four functions. dy dx 0 and 0 dt dt horizontal tangent vertical tangent

r t t x t y t z t, y t are zero, then construct a table for all four functions. dy dx 0 and 0 dt dt horizontal tangent vertical tangent 3. uggestions for the Formula heets Below are some suggestions for many more formulae than can be placed easily on both sides of the two standard 8½"" sheets of paper for the final examination. It is strongly

More information

Econometrics II - EXAM Outline Solutions All questions have 25pts Answer each question in separate sheets

Econometrics II - EXAM Outline Solutions All questions have 25pts Answer each question in separate sheets Econometrics II - EXAM Outline Solutions All questions hae 5pts Answer each question in separate sheets. Consider the two linear simultaneous equations G with two exogeneous ariables K, y γ + y γ + x δ

More information

Chapter 1: Kinematics of Particles

Chapter 1: Kinematics of Particles Chapter 1: Kinematics of Particles 1.1 INTRODUCTION Mechanics the state of rest of motion of bodies subjected to the action of forces Static equilibrium of a body that is either at rest or moes with constant

More information

Math 425 Lecture 1: Vectors in R 3, R n

Math 425 Lecture 1: Vectors in R 3, R n Math 425 Lecture 1: Vectors in R 3, R n Motiating Questions, Problems 1. Find the coordinates of a regular tetrahedron with center at the origin and sides of length 1. 2. What is the angle between the

More information

Drive train. Steering System. Figure 1 Vehicle modeled by subsystems

Drive train. Steering System. Figure 1 Vehicle modeled by subsystems Proceedings of the XII International Symposium on Dynamic Problems of Mechanics (DINAME 7), P.S.Varoto and M.A.Trindade (editors), ABCM, Ilhabela, SP, Brazil, February 6 - March, 7 Wheel Dynamics Georg

More information

E( x ) [b(n) - a(n, m)x(m) ]

E( x ) [b(n) - a(n, m)x(m) ] Homework #, EE5353. An XOR network has two inuts, one hidden unit, and one outut. It is fully connected. Gie the network's weights if the outut unit has a ste actiation and the hidden unit actiation is

More information

Motion in Two and Three Dimensions

Motion in Two and Three Dimensions PH 1-A Fall 014 Motion in Two and Three Dimensions Lectures 4,5 Chapter 4 (Halliday/Resnick/Walker, Fundamentals of Physics 9 th edition) 1 Chapter 4 Motion in Two and Three Dimensions In this chapter

More information

MA 266 Review Topics - Exam # 2 (updated)

MA 266 Review Topics - Exam # 2 (updated) MA 66 Reiew Topics - Exam # updated Spring First Order Differential Equations Separable, st Order Linear, Homogeneous, Exact Second Order Linear Homogeneous with Equations Constant Coefficients The differential

More information

PHYS 1441 Section 002 Lecture #6

PHYS 1441 Section 002 Lecture #6 PHYS 1441 Section 00 Lecture #6 Monday, Feb. 4, 008 Examples for 1-Dim kinematic equations Free Fall Motion in Two Dimensions Maximum ranges and heights Today s homework is homework #3, due 9pm, Monday,

More information

Motion in Two and Three Dimensions

Motion in Two and Three Dimensions PH 1-1D Spring 013 Motion in Two and Three Dimensions Lectures 5,6,7 Chapter 4 (Halliday/Resnick/Walker, Fundamentals of Physics 9 th edition) 1 Chapter 4 Motion in Two and Three Dimensions In this chapter

More information

Note: Each problem is worth 14 points except numbers 5 and 6 which are 15 points. = 3 2

Note: Each problem is worth 14 points except numbers 5 and 6 which are 15 points. = 3 2 Math Prelim II Solutions Spring Note: Each problem is worth points except numbers 5 and 6 which are 5 points. x. Compute x da where is the region in the second quadrant between the + y circles x + y and

More information

Displacement, Time, Velocity

Displacement, Time, Velocity Lecture. Chapter : Motion along a Straight Line Displacement, Time, Velocity 3/6/05 One-Dimensional Motion The area of physics that we focus on is called mechanics: the study of the relationships between

More information

Elements of diffraction theory part II

Elements of diffraction theory part II Elements of diffraction theory part II Setosla S. Iano Department of Physics, St. Kliment Ohridski Uniersity of Sofia, 5 James Bourchier Bld, 1164 Sofia, Bulgaria (Dated: February 7, 2016 We make a brief

More information

Cases of integrability corresponding to the motion of a pendulum on the two-dimensional plane

Cases of integrability corresponding to the motion of a pendulum on the two-dimensional plane Cases of integrability corresponding to the motion of a pendulum on the two-dimensional plane MAXIM V. SHAMOLIN Lomonoso Moscow State Uniersity Institute of Mechanics Michurinskii Ae.,, 99 Moscow RUSSIAN

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

More information

A014 Uncertainty Analysis of Velocity to Resistivity Transforms for Near Field Exploration

A014 Uncertainty Analysis of Velocity to Resistivity Transforms for Near Field Exploration A014 Uncertainty Analysis of Velocity to Resistiity Transforms for Near Field Exploration D. Werthmüller* (Uniersity of Edinburgh), A.M. Ziolkowski (Uniersity of Edinburgh) & D.A. Wright (Uniersity of

More information

Linear Algebra II (finish from last time) Root finding

Linear Algebra II (finish from last time) Root finding Lecture 5: Topics: Linear lgebra II (finish from last time) Root finding -Cross product of two vectors -Finding roots of linear equations -Finding roots of nonlinear equations HW: HW 1, Part 3-4 given

More information

Problem Set 1: Solutions

Problem Set 1: Solutions Uniersity of Alabama Department of Physics and Astronomy PH 253 / LeClair Fall 2010 Problem Set 1: Solutions 1. A classic paradox inoling length contraction and the relatiity of simultaneity is as follows:

More information

E : Ground-penetrating radar (GPR)

E : Ground-penetrating radar (GPR) Geophysics 3 March 009 E : Ground-penetrating radar (GPR) The EM methods in section D use low frequency signals that trael in the Earth by diffusion. These methods can image resistiity of the Earth on

More information

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS 5.1 Introduction When a physical system depends on more than one variable a general

More information

The Inverse Function Theorem

The Inverse Function Theorem Inerse Function Theorem April, 3 The Inerse Function Theorem Suppose and Y are Banach spaces and f : Y is C (continuousl differentiable) Under what circumstances does a (local) inerse f exist? In the simplest

More information

Solutions to the Calculus and Linear Algebra problems on the Comprehensive Examination of January 28, 2011

Solutions to the Calculus and Linear Algebra problems on the Comprehensive Examination of January 28, 2011 Solutions to the Calculus and Linear Algebra problems on the Comprehensive Examination of January 8, Solutions to Problems 5 are omitted since they involve topics no longer covered on the Comprehensive

More information

Multiple Choice. Compute the Jacobian, (u, v), of the coordinate transformation x = u2 v 4, y = uv. (a) 2u 2 + 4v 4 (b) xu yv (c) 3u 2 + 7v 6

Multiple Choice. Compute the Jacobian, (u, v), of the coordinate transformation x = u2 v 4, y = uv. (a) 2u 2 + 4v 4 (b) xu yv (c) 3u 2 + 7v 6 .(5pts) y = uv. ompute the Jacobian, Multiple hoice (x, y) (u, v), of the coordinate transformation x = u v 4, (a) u + 4v 4 (b) xu yv (c) u + 7v 6 (d) u (e) u v uv 4 Solution. u v 4v u = u + 4v 4..(5pts)

More information

MATLAB files for test of Newton s method for 2 nonlinear equations with a solution at (...

MATLAB files for test of Newton s method for 2 nonlinear equations with a solution at (... MATLAB files for test of Newton s method for 2 nonlinear equations with a solution at (... Page 1 of 7 MATLAB files for test of Newton s method for 2 nonlinear equations with a solution at (3,4) This program

More information

Eigenvalues and Eigenvectors

Eigenvalues and Eigenvectors Sec. 6.1 Eigenvalues and Eigenvectors Linear transformations L : V V that go from a vector space to itself are often called linear operators. Many linear operators can be understood geometrically by identifying

More information

Residual migration in VTI media using anisotropy continuation

Residual migration in VTI media using anisotropy continuation Stanford Exploration Project, Report SERGEY, Noember 9, 2000, pages 671?? Residual migration in VTI media using anisotropy continuation Tariq Alkhalifah Sergey Fomel 1 ABSTRACT We introduce anisotropy

More information

v v Downloaded 01/11/16 to Redistribution subject to SEG license or copyright; see Terms of Use at

v v Downloaded 01/11/16 to Redistribution subject to SEG license or copyright; see Terms of Use at The pseudo-analytical method: application of pseudo-laplacians to acoustic and acoustic anisotropic wae propagation John T. Etgen* and Serre Brandsberg-Dahl Summary We generalize the pseudo-spectral method

More information

and let s calculate the image of some vectors under the transformation T.

and let s calculate the image of some vectors under the transformation T. Chapter 5 Eigenvalues and Eigenvectors 5. Eigenvalues and Eigenvectors Let T : R n R n be a linear transformation. Then T can be represented by a matrix (the standard matrix), and we can write T ( v) =

More information

Classical dynamics on graphs

Classical dynamics on graphs Physical Reiew E 63 (21) 66215 (22 pages) Classical dynamics on graphs F. Barra and P. Gaspard Center for Nonlinear Phenomena and Complex Systems, Uniersité Libre de Bruxelles, Campus Plaine C.P. 231,

More information

MIT Final Exam Solutions, Spring 2017

MIT Final Exam Solutions, Spring 2017 MIT 8.6 Final Exam Solutions, Spring 7 Problem : For some real matrix A, the following vectors form a basis for its column space and null space: C(A) = span,, N(A) = span,,. (a) What is the size m n of

More information

Physics 107 HOMEWORK ASSIGNMENT #9b

Physics 107 HOMEWORK ASSIGNMENT #9b Physics 07 HOMEWORK SSIGNMENT #9b Cutnell & Johnson, 7 th edition Chapter : Problems 5, 58, 66, 67, 00 5 Concept Simulation. reiews the concept that plays the central role in this problem. (a) The olume

More information

VISUAL PHYSICS ONLINE RECTLINEAR MOTION: UNIFORM ACCELERATION

VISUAL PHYSICS ONLINE RECTLINEAR MOTION: UNIFORM ACCELERATION VISUAL PHYSICS ONLINE RECTLINEAR MOTION: UNIFORM ACCELERATION Predict Obsere Explain Exercise 1 Take an A4 sheet of paper and a heay object (cricket ball, basketball, brick, book, etc). Predict what will

More information

5. Suggestions for the Formula Sheets

5. Suggestions for the Formula Sheets 5. uggestions for the Formula heets Below are some suggestions for many more formulae than can be placed easily on both sides of the two standard 8½" " sheets of paper for the final examination. It is

More information

Physics 4A Solutions to Chapter 4 Homework

Physics 4A Solutions to Chapter 4 Homework Physics 4A Solutions to Chapter 4 Homework Chapter 4 Questions: 4, 1, 1 Exercises & Problems: 5, 11, 3, 7, 8, 58, 67, 77, 87, 11 Answers to Questions: Q 4-4 (a) all tie (b) 1 and tie (the rocket is shot

More information

arxiv:hep-ph/ v4 8 Dec 2005

arxiv:hep-ph/ v4 8 Dec 2005 Non-Concae Bare Actions with Concae Effectie Actions I: Zero Dimensions E.N. Argyres M.T.M. an Kessel R.H.P. Kleiss April 10, 2017 arxi:hep-ph/05091424 8 Dec 2005 1 Abstract We perform an explicit computation

More information

21.60 Worksheet 8 - preparation problems - question 1:

21.60 Worksheet 8 - preparation problems - question 1: Dynamics 190 1.60 Worksheet 8 - preparation problems - question 1: A particle of mass m moes under the influence of a conseratie central force F (r) =g(r)r where r = xˆx + yŷ + zẑ and r = x + y + z. A.

More information

Linear Momentum and Collisions Conservation of linear momentum

Linear Momentum and Collisions Conservation of linear momentum Unit 4 Linear omentum and Collisions 4.. Conseration of linear momentum 4. Collisions 4.3 Impulse 4.4 Coefficient of restitution (e) 4.. Conseration of linear momentum m m u u m = u = u m Before Collision

More information

Lesson 3: Free fall, Vectors, Motion in a plane (sections )

Lesson 3: Free fall, Vectors, Motion in a plane (sections ) Lesson 3: Free fall, Vectors, Motion in a plane (sections.6-3.5) Last time we looked at position s. time and acceleration s. time graphs. Since the instantaneous elocit is lim t 0 t the (instantaneous)

More information

Online Companion to Pricing Services Subject to Congestion: Charge Per-Use Fees or Sell Subscriptions?

Online Companion to Pricing Services Subject to Congestion: Charge Per-Use Fees or Sell Subscriptions? Online Companion to Pricing Serices Subject to Congestion: Charge Per-Use Fees or Sell Subscriptions? Gérard P. Cachon Pnina Feldman Operations and Information Management, The Wharton School, Uniersity

More information

Homework 3 solutions Math 136 Gyu Eun Lee 2016 April 15. R = b a

Homework 3 solutions Math 136 Gyu Eun Lee 2016 April 15. R = b a Homework 3 solutions Math 136 Gyu Eun Lee 2016 April 15 A problem may have more than one valid method of solution. Here we present just one. Arbitrary functions are assumed to have whatever regularity

More information

Journal of Computational and Applied Mathematics. New matrix iterative methods for constraint solutions of the matrix

Journal of Computational and Applied Mathematics. New matrix iterative methods for constraint solutions of the matrix Journal of Computational and Applied Mathematics 35 (010 76 735 Contents lists aailable at ScienceDirect Journal of Computational and Applied Mathematics journal homepage: www.elseier.com/locate/cam New

More information

LECTURE 3 3.1Rules of Vector Differentiation

LECTURE 3 3.1Rules of Vector Differentiation LETURE 3 3.1Rules of Vector Differentiation We hae defined three kinds of deriaties inoling the operator grad( ) i j k, x y z 1 3 di(., x y z curl( i x 1 j y k z 3 d The good news is that you can apply

More information

are applied to ensure that physical principles are not iolated in the definition of the discrete transition model. The oerall goal is to use this fram

are applied to ensure that physical principles are not iolated in the definition of the discrete transition model. The oerall goal is to use this fram A Comprehensie Methodology for Building Hybrid Models of Physical Systems Pieter J. Mosterman Λ Institute of Robotics and System Dynamics DLR Oberpfaffenhofen P.O. Box 1116 D-8223 Wessling Germany Gautam

More information

(a) During the first part of the motion, the displacement is x 1 = 40 km and the time interval is t 1 (30 km / h) (80 km) 40 km/h. t. (2.

(a) During the first part of the motion, the displacement is x 1 = 40 km and the time interval is t 1 (30 km / h) (80 km) 40 km/h. t. (2. Chapter 3. Since the trip consists of two parts, let the displacements during first and second parts of the motion be x and x, and the corresponding time interals be t and t, respectiely. Now, because

More information

Spring, 2008 CIS 610. Advanced Geometric Methods in Computer Science Jean Gallier Homework 1, Corrected Version

Spring, 2008 CIS 610. Advanced Geometric Methods in Computer Science Jean Gallier Homework 1, Corrected Version Spring, 008 CIS 610 Adanced Geometric Methods in Compter Science Jean Gallier Homework 1, Corrected Version Febrary 18, 008; De March 5, 008 A problems are for practice only, and shold not be trned in.

More information

A Guidance Law for a Mobile Robot for Coverage Applications: A Limited Information Approach

A Guidance Law for a Mobile Robot for Coverage Applications: A Limited Information Approach Proceedings of the Third International Conference on Adances in Control and Optimization of Dynamical Systems, Indian Institute of Technology anpur, India, March 1-15, 014 Frcsh1.6 A Guidance Law for a

More information

Module 1. Energy Methods in Structural Analysis

Module 1. Energy Methods in Structural Analysis Module 1 Energy Methods in Structural Analysis esson 5 Virtual Work Instructional Objecties After studying this lesson, the student will be able to: 1. Define Virtual Work.. Differentiate between external

More information

Calculating determinants for larger matrices

Calculating determinants for larger matrices Day 26 Calculating determinants for larger matrices We now proceed to define det A for n n matrices A As before, we are looking for a function of A that satisfies the product formula det(ab) = det A det

More information

Parameter Estimation in a Cell Cycle Model for Frog Egg Extracts

Parameter Estimation in a Cell Cycle Model for Frog Egg Extracts Parameter Estimation in a Cell Cycle Model for Frog Egg Extracts Jason W. Zwolak, John J. Tyson, and Layne T. Watson Departments of Computer Science and Biology Virginia Polytechnic Institute and State

More information

Vectors in Rn un. This definition of norm is an extension of the Pythagorean Theorem. Consider the vector u = (5, 8) in R 2

Vectors in Rn un. This definition of norm is an extension of the Pythagorean Theorem. Consider the vector u = (5, 8) in R 2 MATH 307 Vectors in Rn Dr. Neal, WKU Matrices of dimension 1 n can be thoght of as coordinates, or ectors, in n- dimensional space R n. We can perform special calclations on these ectors. In particlar,

More information

ξ Da nc n = c Pe ξ = c o ( θ ) (95) c ξ = 0 (96) θ = 0 ; c= c i ξ ( ) (97) (98) Pe z = u L E z

ξ Da nc n = c Pe ξ = c o ( θ ) (95) c ξ = 0 (96) θ = 0 ; c= c i ξ ( ) (97) (98) Pe z = u L E z 5. THE AXIAL DISPERSION MODEL The axial dispersion model can readily be extended to apply to turbulent flow conditions. Under such conditions the velocity profile is almost flat and averaging with respect

More information

6.3 Vectors in a Plane

6.3 Vectors in a Plane 6.3 Vectors in a Plane Plan: Represent ectors as directed line segments. Write the component form of ectors. Perform basic ector operations and represent ectors graphically. Find the direction angles of

More information

COMPARISON OF ANALYTICAL SOLUTIONS FOR CMSMPR CRYSTALLIZER WITH QMOM POPULATION BALANCE MODELING IN FLUENT

COMPARISON OF ANALYTICAL SOLUTIONS FOR CMSMPR CRYSTALLIZER WITH QMOM POPULATION BALANCE MODELING IN FLUENT CHINA PARTICUOLOGY Vol. 3, No. 4, 13-18, 5 COMPARISON OF ANALYTICAL SOLUTIONS FOR CMSMPR CRYSTALLIZER WITH QMOM POPULATION BALANCE MODELING IN FLUENT Bin Wan 1, Terry A. Ring 1, *, Kumar M. Dhanasekharan

More information

9.3 Laminar Flat-Plate Boundary Layer: Exact Solution w-19

9.3 Laminar Flat-Plate Boundary Layer: Exact Solution w-19 9.3 Laminar Flat-Plate Boundary Layer: Exact Solution w-19 Laminar Flat-Plate Boundary Layer: Exact Solution The solution for the laminar boundary layer on a horizontal flat late was obtained by Prtl s

More information

Eigenvalue and Eigenvector Homework

Eigenvalue and Eigenvector Homework Eigenvalue and Eigenvector Homework Olena Bormashenko November 4, 2 For each of the matrices A below, do the following:. Find the characteristic polynomial of A, and use it to find all the eigenvalues

More information