NUMERICAL METHODS FOR FIRST ORDER ODEs

Size: px
Start display at page:

Download "NUMERICAL METHODS FOR FIRST ORDER ODEs"

Transcription

1 COMPUTATIONAL METHODS FOR FLOW IN POROUS MEDIA Sprng 2009 NUMERICAL METHODS FOR FIRST ORDER ODEs Lus Cueto-Felgueroso 1 PROBLEM STATEMENT Consder a system of frst order ordnary dfferental equatons of the form du dt = f(t, u), 0 t T, u(t = 0) = u 0, (1) where u and f are vectors wth N components, u = u(t), and f s n general a nonlnear functon of t and u When f does not depend explctly on t, we say that the system (1) s autonomous We dscretze the tme doman t [0, T ] as 0 = t 0 < t 1 < < t n < < t M 1 < t M = T, (2) and seek numercal methods that approxmate u at at tmes {t n, n = 0,, M}, n the sense that u n u(t = t n ), (3) wth the ntal condton u 0 = u(t = 0) = u 0 The two man famles of numercal methods for ODEs are one-step and multstep methods (Fgure 1) 21 General form 2 LINEAR MULTISTEP METHODS I ADAMS-BASHFORTH The explct Adams methds (Adams-Bashforth) can be wrtten as where β j = ( 1) j 1 k 1 =j 1 u n+1 = u n + t ( j 1 k β j f n j+1, (4) ) γ, and γ = ( 1) 1 The order of these methods s p = k Some examples are gven below 0 ( ) s ds (5)

2 2 NUMERICAL METHODS FOR ODES U n+1 t n+1 t n+1 U 2 t n U 1 t n 1 U n t n t n 2 Fgure 1 Schematc of soluton update n one-step (left) and multstep (rght) methods 211 k=1 (Forward Euler) 212 k=2 u n+1 = u n + tf n (6) u n+1 = u n + t 2 ( 3f n f n 1) (7) 213 k=3 214 k=4 u n+1 = u n + t ( 23f n 16f n 1 + 5f n 2) (8) 12 u n+1 = u n + t ( 55f n 59f n f n 2 9f n 3) (9) 24 3 LINEAR MULTISTEP METHODS II ADAMS-MOULTON 31 General form The mplct Adams methods (Adams-Moulton) can be wrtten as k u n+1 = u n + t β j f n j+1 (10) The order of these schemes s p = k + 1 Some examples are gven below j=0 311 k=0 (Backward Euler) u n+1 = u n + tf n+1 (11)

3 LCF k=1 (Trapezodal rule) u n+1 = u n + t 2 ( f n+1 + f n) (12) 313 k=2 314 k=3 315 k=4 u n+1 = u n + t ( 5f n+1 + 8f n f n 1) (13) 12 u n+1 = u n + t ( 9f n f n 5f n 1 + f n 2) (14) 24 u n+1 = u n + t ( 251f n f n 264f n f n 2 19f n 3) (15) LINEAR MULTISTEP METHODS III BACKWARD DIFFERENTIATION The Backward Dfferentaton Formulas (BDF) are mplct methods, based on one-sded dfferences that approxmate du/dt drectly The general form s k α u n +1 = tβ 0 f n+1 (16) The order of these schemes s p = k Some examples are gven below 406 BDF1, k= 1 (Backward Euler) =0 u n+1 u n = tf n+1 (17) 407 BDF2, k= BDF3, k= 3 u n un un 1 = t 2 3 f n+1 (18) u n un un un 2 = t 6 11 f n+1 (19)

4 4 NUMERICAL METHODS FOR ODES 51 General defnton 5 ONE-STEP METHODS: RUNGE-KUTTA METHODS One step of an s-stage Runge-Kutta scheme can be wrtten as wth stage values u n+1 = u n + t b k, k = f (t n + c t, u ), (20) =1 u = u n + t a j k j (21) In the above expressons, t s the tme step, and A = {a j } R s s, b R s and c R s are the characterstc coeffcents of each gven Runge-Kutta scheme, whch can be compactly wrtten usng the so-called Butcher tableau c 1 a 11 a 12 a 1s c 2 a 21 a 22 a 2s c s a s1 a s2 a ss b 1 b 2 b s b1 b2 bs The consstency vector c defnes the ponts (n tme) at whch the method computes approxmatons to the ntal value problem, so that the stage values can be seen as u u (t n + c t) The row sum condton c = a j, = 1,, s, (22) s usually adopted to smplfy the order condtons for hgh-order methods Explct schemes are characterzed by {a j = 0, j } The second set of coeffcents { b, = 1,, s} corresponds to the embedded scheme, whch s used for error estmaton Thus, a second approxmaton ûu n+1 can be defned usng the same coeffcents A = {a j } R s s, and c R s, and stage values u, = 1,, s, as ûu n+1 = u n + t b k, k = f (t n + c t, u ) (23) =1 The dfference between ûu n+1 and u n+1 gves an estmate of the error ncurred by the numercal approxmaton, thus provdng a crteron for tme step adaptvty

5 LCF 5 52 Dagonally mplct schemes Among mplct RK schemes, the most popular ones for the tme ntegraton of PDEs are dagonally mplct Ther Butcher s tableaux typcally take the form γ γ γ 0 0 c 3 a 31 a 32 γ 0 1 a s,1 a s,2 a s,3 γ b 1 b 2 b 3 γ b1 b2 b3 bs In partcular, these schemes are referred to as Explct frst step, Sngle dagonal coeffcent, Dagonally Implct Runge-Kutta (ESDIRK) methods Each stage value of an ESDIRK scheme s at least second-order accurate 521 Implementaton The stage value computaton n a DIRK scheme reads u = u n + t a j k j (24) Gven that the 1 prevous k s have been prevously computed, (24) can be wrtten as u = E + ta k, 1 E = u n + t a j k j (25) The above expresson s, n general, a nonlnear system of equatons The p + 1 Newton teraton assocated to (25) s gven by ( k p) I ta u p u = E + ta k p (26) where p u = u p+1 u p The embedded scheme uses the same raw nformaton as the orgnal one, but n ths case t s processed usng the second set of weghts, { b, = 1,, s} Thus, at the end of each step of the RK ntegrator, we have u n+1 = u n + t b k =1 ûu n+1 = u n + t b k (27) =1 and the error estmate s gven by some sutable norm of the dfference between these two solutons, r n+1 = u n+1 ûu n+1

6 6 NUMERICAL METHODS FOR ODES 53 Addtve Runge-Kutta schemes: mplct-explct (IMEX) Consder systems of ordnary dfferental equatons that can be wrtten n addtve form as du N dt = f [ν] (t, u) (28) ν=1 where f [1], f [2],, f [N] denote certan terms or components of f, whose dstnctve propertes are worth beng taken nto account separately The above expresson (28) s n prncple qute loose n terms of the consderatons that lead to such splttng In general, t may be advantageous to explot the addtve structure of the system (28) when ether f or the unknowns u themselves present components wth sgnfcantly dfferent tme scales In our PDE numercal soluton context, the former case typcally corresponds to stff-nonstff a pror decompostons of the equatons, whereas the latter could apply to grd-nduced stffness The dea behnd addtve schemes s to use, for each component, the ntegrator that best suts ts partcular characterstcs In the general, N-component case, the ntegraton of (28) can be carred out through the applcaton of N dfferent Runge-Kutta methods, one for each of the components A step of an s stage, N part Addtve (ARK N ) or Parttoned (P RK N ) Runge-Kutta scheme, defned by ts generalzed Butcher tableau s gven by c 1 a [1] 11 a [1] 1s a [N] 11 a [N] 1s c s a [1] s1 a [1] ss a [N] s1 a [N] ss b [1] 1 b [1] s b [N] 1 b [N] s b[1] 1 b[1] s b[n] 1 b[n] s wth stage values where u n+1 = u n + t u = u n + t N =1 ν=1 N ν=1 b [ν] f [ν] (t + c t, u ) (29) a [ν] j f [ν] (t + c j t, u j ) (30) The Butcher coeffcents {a [ν] j c j = }, {b[ν] k=1 a [ν] jk ν = 1,, N (31) }, { b [ν] }, ν = 1,, N and {c } are constraned by certan accuracy and stablty requrements The order condtons of the combned scheme nclude those specfc to each elemental method, and also certan couplng condtons The growth of the number of couplng condtons for ncreasngly hgher order and number of components N s such that the

7 LCF 7 practcal desgn of ARK N methods has been typcally restrcted to N = 2 (ARK 2 ) In ths latter case, the system (28) s conceptually wrtten as du dt = f s (t, u) + f ns (t, u) (32) where the rght hand sde of (28) has been genercally splt nto stff (f s ) and nonstff (f ns ) terms Two dfferent Runge-Kutta schemes, specfcally desgned and coupled, are appled to each term, and the mportant case n our context s the mplct-explct (IMEX) approach, whch acknowledges the fact that the stff part s more effcently dealt wth by means of an mplct ntegrator, whereas the nonstff part can be straghtforwardly ntegrated usng an explct scheme In partcular, many problems of practcal nterest are modeled by partal dfferental equatons whose semdscretzaton can be expressed n the form of (32), where f s (t, U) s lnear but stff, and f ns (t, U) s nonlnear but nonstff The resultng system of ODE s can be very effcently ntegrated usng the IMEX approach The combned ntegrators are referred to as IMEX ARK 2 methods or, when the stff terms are lnear, lnearly mplct Runge-Kutta schemes A popular famly of IMEX ARK 2 schemes take the form γ 2γ c 3 a [E] 31 a [E] a [E] s,1 a [E] s,2 a [E] s,3 0 b [E] 1 b [E] 2 b [E] b[e] 1 b[e] 2 3 γ b[e] 3 b[e] s γ γ γ 0 0 c 3 a [I] 31 a [I] 32 γ 0 1 a [I] s,1 a [I] s,2 a [I] s,3 γ b [I] 1 b [I] 2 b [I] b[i] 1 b[i] 2 3 γ b[i] 3 b[i] s In the above expresson, the superscrpts [E] and [I] have been used n reference to the explct and mplct components of the addtve ARK 2 ntegrator, respectvely The stage order of the mplct ntegrator s two 531 Implementaton One step of an s-stage two-part addtve Runge-Kutta scheme, ARK 2, defned by ts Butcher coeffcents (A [I], A [R], b [I], b [E], b [I], b [E], c), s gven by where k [I] u n+1 = u n + t ( =1 b [I] k [I] + b [E] k [E] and k [E] are the dscrete counterparts of the stff and nonstff operators n (32), f s and f ns, k [I] = f h s (t, u ) k [E] = f h ns (t, u ) (34) and the stage values are defned as u = u n + t ( ) a [I] j k[i] + a [E] j k[e] Restrctng our analyss on ARK 2 pars that use DIRK schemes for the mplct part, the above expresson can be rearranged to obtan ) (33) (35)

8 8 NUMERICAL METHODS FOR ODES 1 ( ) u = u n + t a [I] j k[i] j + a [E] j k[e] j + ta [I] k[i] (36) We are nterested n the lnearly mplct case, for whch the above expresson s a lnear system of equatons of the form where k [I] ( ) I ta [I] K u = u n + t 1 ( ) a [I] j k[i] j + a [E] j k[e] j = Ku After solvng u from (37), we can compute k [I] (37) = f s (t, u ), and k [E] = f ns (t, u ) The error estmator s constructed agan n terms of the soluton provded by the embedded scheme, ûu n+1 = u n + t =1 ( b[i] k [I] + and gven by some sutable norm of the dfference between the orgnal and embedded solutons, r n+1 = u n+1 ûu n+1 b [E] k [E] ) (38)

9 LCF 9 61 Heun s thrd-order method 6 SAMPLE RUNGE-KUTTA METHODS /3 1/ /3 0 2/3 0 1/4 0 3/4 62 Kutta s thrd-order method /2 1/ /6 2/3 1/6 63 Kutta s fourth-order method (assocated to Smpson s frst quadrature rule) /2 1/ /2 0 1/ /6 1/3 1/3 1/6 64 Fourth-order scheme assocated to Smpson s second quadrature rule /3 1/ /3 1/ /8 3/8 3/8 1/8

10 10 NUMERICAL METHODS FOR ODES 65 Fehlberg s method /4 1/ /8 3/32 9/ / / / / / / / /2 8/ / / / / / / /50 2/55 25/ / /4104 1/ Dormand and Prnce s method /5 1/ /10 3/40 9/ /5 44/45 56/15 32/ / / / / / / / / / / / / / / / / / / / / / / / / /2100 1/40 67 Bjl s DIRK method

11 LCF 11 7 IMPLEMENTATION OF EXPLICIT RUNGE-KUTTA METHODS 71 A frst, non-pde example Consder N>1 dogs {d j, j = 1,, N}, that are located at the N vertces of a polygon At t = 0, each dog starts chasng ts neghbor counterclockwse; e d1 d2 d(n 1) dn The relatonshp d chases d( + 1), d d( + 1), s understood n the sense that, for all t 0, the velocty vector assocated to dog ponts towards dog ( + 1) Accordngly, the equatons of moton can be wrtten as dx dt = u dy dt = v = 1, 2,, N, wth ntal condtons x (0) = x 0 and y (0) = y 0 The velocty vector v (t) = (u, v ) s gven by u = c x +1 x r v = c y +1 y r In the above expressons, c s a characterstc dog speed (whch s assumed to be constant n tme and equal for all dogs), and r s the dstance between consecutve dogs, r = (x +1 x ) 2 + (y +1 y ) 2 Assumng c = 1, and that the dogs are ntally located along the unt crcumference, x 0 = cos(θ ) y 0 = sn(θ ), θ = π N + 2π ( 1), = 1,, N, N we may ntegrate the trajectores (x(t), y(t)) usng several Runge-Kutta schemes We wll stop the computaton when the smallest dstance between consecutve dogs s less than δ = 10 4 The tme steps wll be chosen accordng to t n+1 = t n+1 t n = κ mn(r n ) where mn(r n ) s the mnmum dstance between consecutve dogs at tme level tn, and κ s some constant The exact trajectory of the frst dog s gven by where r = e a(θ π/n), θ [ π N, ), (39)

12 12 NUMERICAL METHODS FOR ODES cos 2π a = N 1 sn 2π (40) N The trajectores of the other dogs are dentcal, but shfted 2π N Ths problem s solved by the code dogsrkm, whch can be found n the folder example_rk Each step of an s-stage explct RK method works as follows: - For every stage, we need to compute the stage value usng the f s evaluated at prevous stages, as u = u n + t a j k j (41) Once we compute the stage value, u, we store f(t + c t, u ) In the code, ths corresponds to for stage=1:nstage; accum= u0; for jstage= 1:stage-1; accum= accum + dt*ark(stage,jstage)*f(:,jstage); [f,r]= odefun(t+crk(stage)*dt,accum); F(:,stage)= f; - Once all the stage values and ther assocate f s have been computed, we advance the soluton as In the code, ths reads u n+1 = u n + t b k, k = f (t n + c t, u ) (42) =1 u= u0; for stage= 1:nstage; u= u + dt*brk(stage)*f(:,stage); The code may work wth RK methods of orders 1 to 4 (ther Butcher s tableaux are gven n ButcherTm Convergence results and a sample smulaton wth N = 6 dogs are shown n Fgure 2 The convergence study was carred out usng the code dogsrk_convm

13 LCF k= k= 2 05 error k= 3 0 k= t Fgure 2 Left, convergence of varous explct RK methods n the chasng dogs problem Rght, trajectores for N = 6 dogs 72 Applcaton to PDEs Let s solve the problem u t + u x u µ 2 = 0, µ > 0, t > 0, x [0, 1], (43) x2 usng fnte dfferences and explct Runge-Kutta schemes The ntal condton s u(x, t = 0) = exp( 100(x 05) 2 ), (44) and we wll enforce perodc boundary condtons Ths example s coded n exp_adem (folder explct_ade) We may follow the same framework of the prevous example, once we consder the sem-dscrete problem du dt = f(t, u) = Ku, K = (D 1 µd 2 ), (45) where D 1 and D 2 are the dfferentaton matrces One step of the RK update then reads for stage=1:nstage; accum= u0; for jstage= 1:stage-1; accum= accum + dt*ark(stage,jstage)*f(:,jstage); F(:,stage)= K*accum; u= u0; for stage= 1:nstage; u= u + dt*brk(stage)*f(:,stage);

14 14 NUMERICAL METHODS FOR ODES 81 Lnear case 8 IMPLEMENTATION OF IMPLICIT RUNGE-KUTTA METHODS In the case of (dagonally) mplct RK methods, snce the evaluaton of the stage values u nvolves f tself, we need to solve a system of equatons Let us start wth the same lnear advecton-dffuson equaton of the prevous example, ntal condton u t + u x u µ 2 = 0, µ > 0, t > 0, x [0, 1], (46) x2 u(x, t = 0) = exp( 100(x 05) 2 ), (47) and perodc boundary condtons Remember that the general form of the RK update s gven by wth stage values u n+1 = u n + t b k, k = f (t n + c t, u ), (48) =1 u = u n + t a j k j (49) In the present case, snce we consder DIRK schemes only, the stage values wll be gven by wth u = u n + t a j k j, (50) k j = Ku j, K = (D 1 µd 2 ), (51) where D 1 and D 2 are the dfferentaton matrces Thus, the computaton of stage values may be wrtten as 1 u = u n + t a j k j + ta Ku (52) Rearrangng the above expresson, we arrve at a system of lnear equatons of the form 1 (I ta K) u = u n + t a j k j, (53) that needs to be solved n order to get u The code mp_adem (folder mplct_ade) solves ths problem usng backward Euler and Bjl s DIRK method One step of a DIRK scheme s coded as

15 LCF 15 u0= u; for stage=1:nstage; accum= u0; for jstage= 1:stage-1; accum= accum + dt*ark(stage,jstage)*f(:,jstage); %Solve system of equatons Impmat= eye(n)-dt*ark(stage,stage)*k; u= Impmat\accum; %Compute f(u_) F(:,stage)= K*u; %Fnal update u= u0; for stage= 1:nstage; u= u + dt*brk(stage)*f(:,stage); Note that, n the present case, the matrx K could have been precomputed and nverted only once at the begnnng

16 16 NUMERICAL METHODS FOR ODES 82 Nonlnear case: fully mplct vs mplct-explct Our model problem for the nonlnear case s the Kuramoto-Svashnsky equaton u t + ( ) 1 x 2 u2 + 2 u x u x 4 = 0 (54) Ths equaton s solved n [0, 32π] wth perodc boundary condtons The ntal condton s gven by u(x, t = 0) = cos(x/16) (1 + sn(x/16) (55) In ths equaton, the low-order (advectve) term s nonlnear, whereas the hgher-order terms are lnear The fact that a fourth-order term s present makes the equaton very stff There are two man strateges that could be followed: fully mplct tme steppng, where the three terms are advanced mplctly, and mplct-explct, where the advectve term s advanced explctly and the hgher-order terms mplctly The latter strategy has the advantage that we solve lnear systems of equatons In the former, we need to use Newton teratons to solve the resultng nonlnear systems The fully nonlnear strategy s mplemented n the code mp_ksm (folder mplct_ks) One step of a DIRK scheme s mplemented as u0= u; for stage=1:nstage; accum= u0; for jstage= 1:stage-1; accum= accum + dt*ark(stage,jstage)*f(:,jstage); %Solve system of nonlnear equatons r= 1; whle(r>10ˆ-6); %Jacoban Jac= eye(n) + dt*ark(stage,stage)*(d1*dag(u) + D2 + D4); %Resdual R= u - accum + dt*ark(stage,stage)*(d1*(05*u*u) + D2*u + D4*u); %Update deltau= -Jac\R; u= u+deltau; r= norm(deltau); F(:,stage)= -(D1*(05*u*u) + D2*u + D4*u); u= u0; for stage= 1:nstage; u= u + dt*brk(stage)*f(:,stage); The mplct-explct strategy s mplemented n the code mex_ksm (folder mex_ks) We use one of the the ARK 2 methods developed n [6]The advantage of an IMEX formulaton s that the systems that we need to solve are lnear, and therefore we do not need several Newton teratons as n the fully mplct scheme One step of the IMEX-RK scheme reads

17 LCF 17 Fgure 3 Schematc of soluton update n one-step (left) and multstep (rght) methods u0= u; for stage=1:nstage; accum= u0; for jstage= 1:stage-1; accum= accum + dt*(ae(stage,jstage)*ke(:,jstage)+ AI(stage,jstage)*KI(:,jstage)); f stage>1; u= IKmat*accum; KI(:,stage)= -(D2+D4)*u; KE(:,stage)= -D1*(05*u*u); u= u0; for stage= 1:nstage; u= u + dt*( be(stage)*ke(:,stage) + bi(stage)*ki(:,stage) ); Snce we have precomputed and nverted the matrx of the lnear system of equatons, the tme steppng actually does not requre solvng a system of equatons Of course ths s possble because we are usng a constant tme step t Otherwse, we would need to recompute and nvert K Fgure 3 shows the smulated evoluton of u(x) n space-tme, usng the mplct-explct code, mex_ksm

18 18 NUMERICAL METHODS FOR ODES 91 Lnear multstep methods Multstep methods can be wrtten as 9 Regons of absolute stablty k α j u n j+1 = t j=0 k β j f n j+1 (56) The boundary of the regon of absolute stablty of a multstep method s, based on the above defnton, gven by z = j=0 k α j e ( j+1)θ j=0 (57) k β j e ( j+1)θ j=0 where z = λ t, s the magnary unt, and θ vares between 0 and 2π The regons of absolute stablty of several Adams and BDF methods are plotted n Fgures 4 and 5, respectvely, usng the codes n the folder stab_regons A numercal method s A-stable f ts regon of absolute stablty contans the left half-plane, Re(λ) t < 0 It can be shown that: - An explct lnear multstep method cannot be A-stable - The order of an A-stable lnear multstep method cannot exceed 2 - The second-order A-stable mplct lnear multstep method wth the smallest error constant s the trapezodal method 92 Runge-Kutta methods Recall that the regon of absolute stablty s determned by the complex values z = λ t for whch, when the method s appled to the test equaton du dt = λu, (58) we get u n+1 u n One step of an explct Runge-Kutta method appled to the above test equaton can be wrtten as [ ] u n+1 = 1 + zb T (I za) 1 1 u n (59) Expandng the nverse operator, we can rewrte the above expresson as or u n+1 = [ 1 + zb T ( I + za + + z k A k + ) 1 ] u n, (60) u n+1 = R(z)u n (61)

19 LCF 19 Fgure 4 Regons of absolute stablty of Adams methods Left, Adams-Bashforth Rght, Adams-Moulton Fgure 5 Regons of absolute stablty of backward dfferentaton formulas Left, k = 1 4 Rght, k = 4 6

20 20 NUMERICAL METHODS FOR ODES Fgure 6 Regons of absolute stablty of explct Runge-Kutta methods wth p = s 4 For a Runge-Kutta method of order p, we get R(z) = 1 + z + z zp p! + j=p+1 z j b T A j 1 1 (62) In partcular, the regon of absolute stablty of an explct pth-order Runge-Kutta method wth s stages and order p = s 4, s gven by 1 + z + z zp 1 (63) p! Note that all p-stage explct RK methods of order p have the same regon of absolute stablty For an s-stage method of order p < s the stablty regon depends on the method s coeffcents The stablty regons of explct RK methods wth p = s 4 are plotted n Fgure 6, usng the code regons_rkm 10 Stablty of the method of lnes The practcal relevance of determnng the regon of absolute stablty of a gven tme ntegraton scheme s that the egenvalues of our spatal dscretzaton matrx, multpled by t, have to fall nsde that regon The codes n the folder stab_mol assemble the dscretzaton matrces for the model equaton u t + u x + µ 2 u 2 x 2 + µ 3 u 3 x 3 + µ 4 u 4 = 0, (64) x4 and plot the scaled egenvalues together wth the regons of absolute stablty of varous ODE solvers Fgure 7 shows the stablty regons for the Adams-Bashforth and explct Runge-Kutta methods,

21 LCF 21 Fgure 7 Stablty of the method of lnes t-scaled egenvalues for the model problem (65), and regons of absolute stablty of common explct schemes Left, Adams-Basforth methods Rght, Runge-Kutta methods The egenvalues correspond to three dfferent values of the dffusvty, µ together wth the t-scaled egenvalues of a fnte dfference dscretzaton of the model problem u t + u x u µ 2 = 0, (65) x2 for several values of the dffusvty µ We therefore compute the egenvalues {λ j } of the dscretzaton matrx K, K = D 1 + µd 2, (66) and multply them by t As µ ncreases, the scaled egenvalues advance quckly nsde the left halfplane, whch n practce means that we need small tme steps (the problem becomes stff) In that stuaton, A-stable methods provde sgnfcant advantages, snce the tme step can be chosen based on accuracy requrements, rather than based on stablty restrctons BIBLIOGRAPHY 1 Harer E, Nørsett SP, Wanner G Solvng ordnary dfferental equatons (vols 1 and 2) Sprnger-Verlag, Berln, (1993) 2 Butcher JC Numercal methods for ordnary dfferental equatons John Wley & Sons, Chchester, (2008) 3 Ascher UM, Petzold LR Computer methods for ordnary dfferental equatons and dfferental-algebrac equatons SIAM, Phladelpha, (1998) 4 Araújo AL, Murúa A, Sanz-Serna JM Symplectc methods based on decompostons SIAM J Numer Anal 34, , (1997) 5 Ascher UM, Ruuth SJ, Spter RJ Implct-explct Runge-Kutta methods for tme-dependent partal dfferental equatons Appl Numer Math 25, , (1997) 6 Kennedy CA, Carpenter MH Addtve Runge-Kutta schemes for convecton-dffuson-reacton equatons Appl Numer Math 44, , (2003)

Appendix B. The Finite Difference Scheme

Appendix B. The Finite Difference Scheme 140 APPENDIXES Appendx B. The Fnte Dfference Scheme In ths appendx we present numercal technques whch are used to approxmate solutons of system 3.1 3.3. A comprehensve treatment of theoretcal and mplementaton

More information

CHAPTER 5 NUMERICAL EVALUATION OF DYNAMIC RESPONSE

CHAPTER 5 NUMERICAL EVALUATION OF DYNAMIC RESPONSE CHAPTER 5 NUMERICAL EVALUATION OF DYNAMIC RESPONSE Analytcal soluton s usually not possble when exctaton vares arbtrarly wth tme or f the system s nonlnear. Such problems can be solved by numercal tmesteppng

More information

Lecture 12: Discrete Laplacian

Lecture 12: Discrete Laplacian Lecture 12: Dscrete Laplacan Scrbe: Tanye Lu Our goal s to come up wth a dscrete verson of Laplacan operator for trangulated surfaces, so that we can use t n practce to solve related problems We are mostly

More information

NON-CENTRAL 7-POINT FORMULA IN THE METHOD OF LINES FOR PARABOLIC AND BURGERS' EQUATIONS

NON-CENTRAL 7-POINT FORMULA IN THE METHOD OF LINES FOR PARABOLIC AND BURGERS' EQUATIONS IJRRAS 8 (3 September 011 www.arpapress.com/volumes/vol8issue3/ijrras_8_3_08.pdf NON-CENTRAL 7-POINT FORMULA IN THE METHOD OF LINES FOR PARABOLIC AND BURGERS' EQUATIONS H.O. Bakodah Dept. of Mathematc

More information

Consistency & Convergence

Consistency & Convergence /9/007 CHE 374 Computatonal Methods n Engneerng Ordnary Dfferental Equatons Consstency, Convergence, Stablty, Stffness and Adaptve and Implct Methods ODE s n MATLAB, etc Consstency & Convergence Consstency

More information

Chapter 5. Solution of System of Linear Equations. Module No. 6. Solution of Inconsistent and Ill Conditioned Systems

Chapter 5. Solution of System of Linear Equations. Module No. 6. Solution of Inconsistent and Ill Conditioned Systems Numercal Analyss by Dr. Anta Pal Assstant Professor Department of Mathematcs Natonal Insttute of Technology Durgapur Durgapur-713209 emal: anta.bue@gmal.com 1 . Chapter 5 Soluton of System of Lnear Equatons

More information

Difference Equations

Difference Equations Dfference Equatons c Jan Vrbk 1 Bascs Suppose a sequence of numbers, say a 0,a 1,a,a 3,... s defned by a certan general relatonshp between, say, three consecutve values of the sequence, e.g. a + +3a +1

More information

4DVAR, according to the name, is a four-dimensional variational method.

4DVAR, according to the name, is a four-dimensional variational method. 4D-Varatonal Data Assmlaton (4D-Var) 4DVAR, accordng to the name, s a four-dmensonal varatonal method. 4D-Var s actually a drect generalzaton of 3D-Var to handle observatons that are dstrbuted n tme. The

More information

Transfer Functions. Convenient representation of a linear, dynamic model. A transfer function (TF) relates one input and one output: ( ) system

Transfer Functions. Convenient representation of a linear, dynamic model. A transfer function (TF) relates one input and one output: ( ) system Transfer Functons Convenent representaton of a lnear, dynamc model. A transfer functon (TF) relates one nput and one output: x t X s y t system Y s The followng termnology s used: x y nput output forcng

More information

Lectures - Week 4 Matrix norms, Conditioning, Vector Spaces, Linear Independence, Spanning sets and Basis, Null space and Range of a Matrix

Lectures - Week 4 Matrix norms, Conditioning, Vector Spaces, Linear Independence, Spanning sets and Basis, Null space and Range of a Matrix Lectures - Week 4 Matrx norms, Condtonng, Vector Spaces, Lnear Independence, Spannng sets and Bass, Null space and Range of a Matrx Matrx Norms Now we turn to assocatng a number to each matrx. We could

More information

Lecture 21: Numerical methods for pricing American type derivatives

Lecture 21: Numerical methods for pricing American type derivatives Lecture 21: Numercal methods for prcng Amercan type dervatves Xaoguang Wang STAT 598W Aprl 10th, 2014 (STAT 598W) Lecture 21 1 / 26 Outlne 1 Fnte Dfference Method Explct Method Penalty Method (STAT 598W)

More information

Lecture 5.8 Flux Vector Splitting

Lecture 5.8 Flux Vector Splitting Lecture 5.8 Flux Vector Splttng 1 Flux Vector Splttng The vector E n (5.7.) can be rewrtten as E = AU (5.8.1) (wth A as gven n (5.7.4) or (5.7.6) ) whenever, the equaton of state s of the separable form

More information

Formal solvers of the RT equation

Formal solvers of the RT equation Formal solvers of the RT equaton Formal RT solvers Runge- Kutta (reference solver) Pskunov N.: 979, Master Thess Long characterstcs (Feautrer scheme) Cannon C.J.: 970, ApJ 6, 55 Short characterstcs (Hermtan

More information

Numerical Heat and Mass Transfer

Numerical Heat and Mass Transfer Master degree n Mechancal Engneerng Numercal Heat and Mass Transfer 06-Fnte-Dfference Method (One-dmensonal, steady state heat conducton) Fausto Arpno f.arpno@uncas.t Introducton Why we use models and

More information

E91: Dynamics. E91: Dynamics. Numerical Integration & State Space Representation

E91: Dynamics. E91: Dynamics. Numerical Integration & State Space Representation E91: Dnamcs Numercal Integraton & State Space Representaton The Algorthm In steps of Δ f ( new ) f ( old ) df ( d old ) Δ Numercal Integraton of ODEs d d f() h Δ Intal value problem: Gven the ntal state

More information

2 Finite difference basics

2 Finite difference basics Numersche Methoden 1, WS 11/12 B.J.P. Kaus 2 Fnte dfference bascs Consder the one- The bascs of the fnte dfference method are best understood wth an example. dmensonal transent heat conducton equaton T

More information

EEE 241: Linear Systems

EEE 241: Linear Systems EEE : Lnear Systems Summary #: Backpropagaton BACKPROPAGATION The perceptron rule as well as the Wdrow Hoff learnng were desgned to tran sngle layer networks. They suffer from the same dsadvantage: they

More information

The equation of motion of a dynamical system is given by a set of differential equations. That is (1)

The equation of motion of a dynamical system is given by a set of differential equations. That is (1) Dynamcal Systems Many engneerng and natural systems are dynamcal systems. For example a pendulum s a dynamcal system. State l The state of the dynamcal system specfes t condtons. For a pendulum n the absence

More information

Note 10. Modeling and Simulation of Dynamic Systems

Note 10. Modeling and Simulation of Dynamic Systems Lecture Notes of ME 475: Introducton to Mechatroncs Note 0 Modelng and Smulaton of Dynamc Systems Department of Mechancal Engneerng, Unversty Of Saskatchewan, 57 Campus Drve, Saskatoon, SK S7N 5A9, Canada

More information

NUMERICAL DIFFERENTIATION

NUMERICAL DIFFERENTIATION NUMERICAL DIFFERENTIATION 1 Introducton Dfferentaton s a method to compute the rate at whch a dependent output y changes wth respect to the change n the ndependent nput x. Ths rate of change s called the

More information

Some modelling aspects for the Matlab implementation of MMA

Some modelling aspects for the Matlab implementation of MMA Some modellng aspects for the Matlab mplementaton of MMA Krster Svanberg krlle@math.kth.se Optmzaton and Systems Theory Department of Mathematcs KTH, SE 10044 Stockholm September 2004 1. Consdered optmzaton

More information

Numerical Solution of Ordinary Differential Equations

Numerical Solution of Ordinary Differential Equations Numercal Methods (CENG 00) CHAPTER-VI Numercal Soluton of Ordnar Dfferental Equatons 6 Introducton Dfferental equatons are equatons composed of an unknown functon and ts dervatves The followng are examples

More information

Structure and Drive Paul A. Jensen Copyright July 20, 2003

Structure and Drive Paul A. Jensen Copyright July 20, 2003 Structure and Drve Paul A. Jensen Copyrght July 20, 2003 A system s made up of several operatons wth flow passng between them. The structure of the system descrbes the flow paths from nputs to outputs.

More information

Errors for Linear Systems

Errors for Linear Systems Errors for Lnear Systems When we solve a lnear system Ax b we often do not know A and b exactly, but have only approxmatons  and ˆb avalable. Then the best thng we can do s to solve ˆx ˆb exactly whch

More information

Digital Signal Processing

Digital Signal Processing Dgtal Sgnal Processng Dscrete-tme System Analyss Manar Mohasen Offce: F8 Emal: manar.subh@ut.ac.r School of IT Engneerng Revew of Precedent Class Contnuous Sgnal The value of the sgnal s avalable over

More information

page 2 2 dscretzaton mantans ths stablty under a sutable restrcton on the tme step. SSP tme dscretzaton methods were frst developed by Shu n [20] and

page 2 2 dscretzaton mantans ths stablty under a sutable restrcton on the tme step. SSP tme dscretzaton methods were frst developed by Shu n [20] and page 1 A Survey of Strong Stablty Preservng Hgh Order Tme Dscretzatons Ch-Wang Shu Λ 1 Introducton Numercal soluton for ordnary dfferental equatons (ODEs) s an establshed research area. There are many

More information

Key Words: Hamiltonian systems, canonical integrators, symplectic integrators, Runge-Kutta-Nyström methods.

Key Words: Hamiltonian systems, canonical integrators, symplectic integrators, Runge-Kutta-Nyström methods. CANONICAL RUNGE-KUTTA-NYSTRÖM METHODS OF ORDERS 5 AND 6 DANIEL I. OKUNBOR AND ROBERT D. SKEEL DEPARTMENT OF COMPUTER SCIENCE UNIVERSITY OF ILLINOIS AT URBANA-CHAMPAIGN 304 W. SPRINGFIELD AVE. URBANA, ILLINOIS

More information

FTCS Solution to the Heat Equation

FTCS Solution to the Heat Equation FTCS Soluton to the Heat Equaton ME 448/548 Notes Gerald Recktenwald Portland State Unversty Department of Mechancal Engneerng gerry@pdx.edu ME 448/548: FTCS Soluton to the Heat Equaton Overvew 1. Use

More information

Linear Regression Analysis: Terminology and Notation

Linear Regression Analysis: Terminology and Notation ECON 35* -- Secton : Basc Concepts of Regresson Analyss (Page ) Lnear Regresson Analyss: Termnology and Notaton Consder the generc verson of the smple (two-varable) lnear regresson model. It s represented

More information

Global Sensitivity. Tuesday 20 th February, 2018

Global Sensitivity. Tuesday 20 th February, 2018 Global Senstvty Tuesday 2 th February, 28 ) Local Senstvty Most senstvty analyses [] are based on local estmates of senstvty, typcally by expandng the response n a Taylor seres about some specfc values

More information

Chapter 12. Ordinary Differential Equation Boundary Value (BV) Problems

Chapter 12. Ordinary Differential Equation Boundary Value (BV) Problems Chapter. Ordnar Dfferental Equaton Boundar Value (BV) Problems In ths chapter we wll learn how to solve ODE boundar value problem. BV ODE s usuall gven wth x beng the ndependent space varable. p( x) q(

More information

DUE: WEDS FEB 21ST 2018

DUE: WEDS FEB 21ST 2018 HOMEWORK # 1: FINITE DIFFERENCES IN ONE DIMENSION DUE: WEDS FEB 21ST 2018 1. Theory Beam bendng s a classcal engneerng analyss. The tradtonal soluton technque makes smplfyng assumptons such as a constant

More information

Module 3 LOSSY IMAGE COMPRESSION SYSTEMS. Version 2 ECE IIT, Kharagpur

Module 3 LOSSY IMAGE COMPRESSION SYSTEMS. Version 2 ECE IIT, Kharagpur Module 3 LOSSY IMAGE COMPRESSION SYSTEMS Verson ECE IIT, Kharagpur Lesson 6 Theory of Quantzaton Verson ECE IIT, Kharagpur Instructonal Objectves At the end of ths lesson, the students should be able to:

More information

Inductance Calculation for Conductors of Arbitrary Shape

Inductance Calculation for Conductors of Arbitrary Shape CRYO/02/028 Aprl 5, 2002 Inductance Calculaton for Conductors of Arbtrary Shape L. Bottura Dstrbuton: Internal Summary In ths note we descrbe a method for the numercal calculaton of nductances among conductors

More information

LINEAR REGRESSION ANALYSIS. MODULE IX Lecture Multicollinearity

LINEAR REGRESSION ANALYSIS. MODULE IX Lecture Multicollinearity LINEAR REGRESSION ANALYSIS MODULE IX Lecture - 30 Multcollnearty Dr. Shalabh Department of Mathematcs and Statstcs Indan Insttute of Technology Kanpur 2 Remedes for multcollnearty Varous technques have

More information

Handout # 6 (MEEN 617) Numerical Integration to Find Time Response of SDOF mechanical system. and write EOM (1) as two first-order Eqs.

Handout # 6 (MEEN 617) Numerical Integration to Find Time Response of SDOF mechanical system. and write EOM (1) as two first-order Eqs. Handout # 6 (MEEN 67) Numercal Integraton to Fnd Tme Response of SDOF mechancal system State Space Method The EOM for a lnear system s M X + DX + K X = F() t () t = X = X X = X = V wth ntal condtons, at

More information

High resolution entropy stable scheme for shallow water equations

High resolution entropy stable scheme for shallow water equations Internatonal Symposum on Computers & Informatcs (ISCI 05) Hgh resoluton entropy stable scheme for shallow water equatons Xaohan Cheng,a, Yufeng Ne,b, Department of Appled Mathematcs, Northwestern Polytechncal

More information

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 12

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 12 REVIEW Lecture 11: 2.29 Numercal Flud Mechancs Fall 2011 Lecture 12 End of (Lnear) Algebrac Systems Gradent Methods Krylov Subspace Methods Precondtonng of Ax=b FINITE DIFFERENCES Classfcaton of Partal

More information

STAT 309: MATHEMATICAL COMPUTATIONS I FALL 2018 LECTURE 16

STAT 309: MATHEMATICAL COMPUTATIONS I FALL 2018 LECTURE 16 STAT 39: MATHEMATICAL COMPUTATIONS I FALL 218 LECTURE 16 1 why teratve methods f we have a lnear system Ax = b where A s very, very large but s ether sparse or structured (eg, banded, Toepltz, banded plus

More information

On a direct solver for linear least squares problems

On a direct solver for linear least squares problems ISSN 2066-6594 Ann. Acad. Rom. Sc. Ser. Math. Appl. Vol. 8, No. 2/2016 On a drect solver for lnear least squares problems Constantn Popa Abstract The Null Space (NS) algorthm s a drect solver for lnear

More information

Professor Terje Haukaas University of British Columbia, Vancouver The Q4 Element

Professor Terje Haukaas University of British Columbia, Vancouver  The Q4 Element Professor Terje Haukaas Unversty of Brtsh Columba, ancouver www.nrsk.ubc.ca The Q Element Ths document consders fnte elements that carry load only n ther plane. These elements are sometmes referred to

More information

Additional Codes using Finite Difference Method. 1 HJB Equation for Consumption-Saving Problem Without Uncertainty

Additional Codes using Finite Difference Method. 1 HJB Equation for Consumption-Saving Problem Without Uncertainty Addtonal Codes usng Fnte Dfference Method Benamn Moll 1 HJB Equaton for Consumpton-Savng Problem Wthout Uncertanty Before consderng the case wth stochastc ncome n http://www.prnceton.edu/~moll/ HACTproect/HACT_Numercal_Appendx.pdf,

More information

MATH 5630: Discrete Time-Space Model Hung Phan, UMass Lowell March 1, 2018

MATH 5630: Discrete Time-Space Model Hung Phan, UMass Lowell March 1, 2018 MATH 5630: Dscrete Tme-Space Model Hung Phan, UMass Lowell March, 08 Newton s Law of Coolng Consder the coolng of a well strred coffee so that the temperature does not depend on space Newton s law of collng

More information

The Finite Element Method

The Finite Element Method The Fnte Element Method GENERAL INTRODUCTION Read: Chapters 1 and 2 CONTENTS Engneerng and analyss Smulaton of a physcal process Examples mathematcal model development Approxmate solutons and methods of

More information

A PROCEDURE FOR SIMULATING THE NONLINEAR CONDUCTION HEAT TRANSFER IN A BODY WITH TEMPERATURE DEPENDENT THERMAL CONDUCTIVITY.

A PROCEDURE FOR SIMULATING THE NONLINEAR CONDUCTION HEAT TRANSFER IN A BODY WITH TEMPERATURE DEPENDENT THERMAL CONDUCTIVITY. Proceedngs of the th Brazlan Congress of Thermal Scences and Engneerng -- ENCIT 006 Braz. Soc. of Mechancal Scences and Engneerng -- ABCM, Curtba, Brazl,- Dec. 5-8, 006 A PROCEDURE FOR SIMULATING THE NONLINEAR

More information

Physics 5153 Classical Mechanics. D Alembert s Principle and The Lagrangian-1

Physics 5153 Classical Mechanics. D Alembert s Principle and The Lagrangian-1 P. Guterrez Physcs 5153 Classcal Mechancs D Alembert s Prncple and The Lagrangan 1 Introducton The prncple of vrtual work provdes a method of solvng problems of statc equlbrum wthout havng to consder the

More information

More metrics on cartesian products

More metrics on cartesian products More metrcs on cartesan products If (X, d ) are metrc spaces for 1 n, then n Secton II4 of the lecture notes we defned three metrcs on X whose underlyng topologes are the product topology The purpose of

More information

Some new additive Runge Kutta methods and their applications

Some new additive Runge Kutta methods and their applications Journal of Computatonal and Appled Mathematcs 9 (6) 74 98 www.elsever.com/locate/cam Some new addtve Runge Kutta methods and ther applcatons Hongyu Lu,, Jun Zou Department of Mathematcs, The Chnese Unversty

More information

The Geometry of Logit and Probit

The Geometry of Logit and Probit The Geometry of Logt and Probt Ths short note s meant as a supplement to Chapters and 3 of Spatal Models of Parlamentary Votng and the notaton and reference to fgures n the text below s to those two chapters.

More information

Lecture 10 Support Vector Machines II

Lecture 10 Support Vector Machines II Lecture 10 Support Vector Machnes II 22 February 2016 Taylor B. Arnold Yale Statstcs STAT 365/665 1/28 Notes: Problem 3 s posted and due ths upcomng Frday There was an early bug n the fake-test data; fxed

More information

Workshop: Approximating energies and wave functions Quantum aspects of physical chemistry

Workshop: Approximating energies and wave functions Quantum aspects of physical chemistry Workshop: Approxmatng energes and wave functons Quantum aspects of physcal chemstry http://quantum.bu.edu/pltl/6/6.pdf Last updated Thursday, November 7, 25 7:9:5-5: Copyrght 25 Dan Dll (dan@bu.edu) Department

More information

Finite Element Modelling of truss/cable structures

Finite Element Modelling of truss/cable structures Pet Schreurs Endhoven Unversty of echnology Department of Mechancal Engneerng Materals echnology November 3, 214 Fnte Element Modellng of truss/cable structures 1 Fnte Element Analyss of prestressed structures

More information

Lecture 2: Numerical Methods for Differentiations and Integrations

Lecture 2: Numerical Methods for Differentiations and Integrations Numercal Smulaton of Space Plasmas (I [AP-4036] Lecture 2 by Lng-Hsao Lyu March, 2018 Lecture 2: Numercal Methods for Dfferentatons and Integratons As we have dscussed n Lecture 1 that numercal smulaton

More information

Problem adapted reduced models based on Reaction-Diffusion Manifolds (REDIMs)

Problem adapted reduced models based on Reaction-Diffusion Manifolds (REDIMs) Problem adapted reduced models based on Reacton-Dffuson Manfolds (REDIMs) V Bykov, U Maas Thrty-Second Internatonal Symposum on ombuston, Montreal, anada, 3-8 August, 8 Problem Statement: Smulaton of reactng

More information

Linear Approximation with Regularization and Moving Least Squares

Linear Approximation with Regularization and Moving Least Squares Lnear Approxmaton wth Regularzaton and Movng Least Squares Igor Grešovn May 007 Revson 4.6 (Revson : March 004). 5 4 3 0.5 3 3.5 4 Contents: Lnear Fttng...4. Weghted Least Squares n Functon Approxmaton...

More information

One-sided finite-difference approximations suitable for use with Richardson extrapolation

One-sided finite-difference approximations suitable for use with Richardson extrapolation Journal of Computatonal Physcs 219 (2006) 13 20 Short note One-sded fnte-dfference approxmatons sutable for use wth Rchardson extrapolaton Kumar Rahul, S.N. Bhattacharyya * Department of Mechancal Engneerng,

More information

Relaxation Methods for Iterative Solution to Linear Systems of Equations

Relaxation Methods for Iterative Solution to Linear Systems of Equations Relaxaton Methods for Iteratve Soluton to Lnear Systems of Equatons Gerald Recktenwald Portland State Unversty Mechancal Engneerng Department gerry@pdx.edu Overvew Techncal topcs Basc Concepts Statonary

More information

November 5, 2002 SE 180: Earthquake Engineering SE 180. Final Project

November 5, 2002 SE 180: Earthquake Engineering SE 180. Final Project SE 8 Fnal Project Story Shear Frame u m Gven: u m L L m L L EI ω ω Solve for m Story Bendng Beam u u m L m L Gven: m L L EI ω ω Solve for m 3 3 Story Shear Frame u 3 m 3 Gven: L 3 m m L L L 3 EI ω ω ω

More information

Salmon: Lectures on partial differential equations. Consider the general linear, second-order PDE in the form. ,x 2

Salmon: Lectures on partial differential equations. Consider the general linear, second-order PDE in the form. ,x 2 Salmon: Lectures on partal dfferental equatons 5. Classfcaton of second-order equatons There are general methods for classfyng hgher-order partal dfferental equatons. One s very general (applyng even to

More information

1 Matrix representations of canonical matrices

1 Matrix representations of canonical matrices 1 Matrx representatons of canoncal matrces 2-d rotaton around the orgn: ( ) cos θ sn θ R 0 = sn θ cos θ 3-d rotaton around the x-axs: R x = 1 0 0 0 cos θ sn θ 0 sn θ cos θ 3-d rotaton around the y-axs:

More information

PHYS 705: Classical Mechanics. Calculus of Variations II

PHYS 705: Classical Mechanics. Calculus of Variations II 1 PHYS 705: Classcal Mechancs Calculus of Varatons II 2 Calculus of Varatons: Generalzaton (no constrant yet) Suppose now that F depends on several dependent varables : We need to fnd such that has a statonary

More information

6.3.4 Modified Euler s method of integration

6.3.4 Modified Euler s method of integration 6.3.4 Modfed Euler s method of ntegraton Before dscussng the applcaton of Euler s method for solvng the swng equatons, let us frst revew the basc Euler s method of numercal ntegraton. Let the general from

More information

Time-Varying Systems and Computations Lecture 6

Time-Varying Systems and Computations Lecture 6 Tme-Varyng Systems and Computatons Lecture 6 Klaus Depold 14. Januar 2014 The Kalman Flter The Kalman estmaton flter attempts to estmate the actual state of an unknown dscrete dynamcal system, gven nosy

More information

A Bayes Algorithm for the Multitask Pattern Recognition Problem Direct Approach

A Bayes Algorithm for the Multitask Pattern Recognition Problem Direct Approach A Bayes Algorthm for the Multtask Pattern Recognton Problem Drect Approach Edward Puchala Wroclaw Unversty of Technology, Char of Systems and Computer etworks, Wybrzeze Wyspanskego 7, 50-370 Wroclaw, Poland

More information

A new Approach for Solving Linear Ordinary Differential Equations

A new Approach for Solving Linear Ordinary Differential Equations , ISSN 974-57X (Onlne), ISSN 974-5718 (Prnt), Vol. ; Issue No. 1; Year 14, Copyrght 13-14 by CESER PUBLICATIONS A new Approach for Solvng Lnear Ordnary Dfferental Equatons Fawz Abdelwahd Department of

More information

C/CS/Phy191 Problem Set 3 Solutions Out: Oct 1, 2008., where ( 00. ), so the overall state of the system is ) ( ( ( ( 00 ± 11 ), Φ ± = 1

C/CS/Phy191 Problem Set 3 Solutions Out: Oct 1, 2008., where ( 00. ), so the overall state of the system is ) ( ( ( ( 00 ± 11 ), Φ ± = 1 C/CS/Phy9 Problem Set 3 Solutons Out: Oct, 8 Suppose you have two qubts n some arbtrary entangled state ψ You apply the teleportaton protocol to each of the qubts separately What s the resultng state obtaned

More information

Inner Product. Euclidean Space. Orthonormal Basis. Orthogonal

Inner Product. Euclidean Space. Orthonormal Basis. Orthogonal Inner Product Defnton 1 () A Eucldean space s a fnte-dmensonal vector space over the reals R, wth an nner product,. Defnton 2 (Inner Product) An nner product, on a real vector space X s a symmetrc, blnear,

More information

CIVL 8/7117 Chapter 10 - Isoparametric Formulation 42/56

CIVL 8/7117 Chapter 10 - Isoparametric Formulation 42/56 CIVL 8/77 Chapter 0 - Isoparametrc Formulaton 4/56 Newton-Cotes Example Usng the Newton-Cotes method wth = ntervals (n = 3 samplng ponts), evaluate the ntegrals: x x cos dx 3 x x dx 3 x x dx 4.3333333

More information

PHYS 705: Classical Mechanics. Canonical Transformation II

PHYS 705: Classical Mechanics. Canonical Transformation II 1 PHYS 705: Classcal Mechancs Canoncal Transformaton II Example: Harmonc Oscllator f ( x) x m 0 x U( x) x mx x LT U m Defne or L p p mx x x m mx x H px L px p m p x m m H p 1 x m p m 1 m H x p m x m m

More information

Psychology 282 Lecture #24 Outline Regression Diagnostics: Outliers

Psychology 282 Lecture #24 Outline Regression Diagnostics: Outliers Psychology 282 Lecture #24 Outlne Regresson Dagnostcs: Outlers In an earler lecture we studed the statstcal assumptons underlyng the regresson model, ncludng the followng ponts: Formal statement of assumptons.

More information

Generalized Linear Methods

Generalized Linear Methods Generalzed Lnear Methods 1 Introducton In the Ensemble Methods the general dea s that usng a combnaton of several weak learner one could make a better learner. More formally, assume that we have a set

More information

Lecture 13 APPROXIMATION OF SECOMD ORDER DERIVATIVES

Lecture 13 APPROXIMATION OF SECOMD ORDER DERIVATIVES COMPUTATIONAL FLUID DYNAMICS: FDM: Appromaton of Second Order Dervatves Lecture APPROXIMATION OF SECOMD ORDER DERIVATIVES. APPROXIMATION OF SECOND ORDER DERIVATIVES Second order dervatves appear n dffusve

More information

New Method for Solving Poisson Equation. on Irregular Domains

New Method for Solving Poisson Equation. on Irregular Domains Appled Mathematcal Scences Vol. 6 01 no. 8 369 380 New Method for Solvng Posson Equaton on Irregular Domans J. Izadan and N. Karamooz Department of Mathematcs Facult of Scences Mashhad BranchIslamc Azad

More information

MMA and GCMMA two methods for nonlinear optimization

MMA and GCMMA two methods for nonlinear optimization MMA and GCMMA two methods for nonlnear optmzaton Krster Svanberg Optmzaton and Systems Theory, KTH, Stockholm, Sweden. krlle@math.kth.se Ths note descrbes the algorthms used n the author s 2007 mplementatons

More information

Module 3: Element Properties Lecture 1: Natural Coordinates

Module 3: Element Properties Lecture 1: Natural Coordinates Module 3: Element Propertes Lecture : Natural Coordnates Natural coordnate system s bascally a local coordnate system whch allows the specfcaton of a pont wthn the element by a set of dmensonless numbers

More information

Comparison of Regression Lines

Comparison of Regression Lines STATGRAPHICS Rev. 9/13/2013 Comparson of Regresson Lnes Summary... 1 Data Input... 3 Analyss Summary... 4 Plot of Ftted Model... 6 Condtonal Sums of Squares... 6 Analyss Optons... 7 Forecasts... 8 Confdence

More information

Singular Value Decomposition: Theory and Applications

Singular Value Decomposition: Theory and Applications Sngular Value Decomposton: Theory and Applcatons Danel Khashab Sprng 2015 Last Update: March 2, 2015 1 Introducton A = UDV where columns of U and V are orthonormal and matrx D s dagonal wth postve real

More information

ME 501A Seminar in Engineering Analysis Page 1

ME 501A Seminar in Engineering Analysis Page 1 umercal Solutons of oundary-value Problems n Os ovember 7, 7 umercal Solutons of oundary- Value Problems n Os Larry aretto Mechancal ngneerng 5 Semnar n ngneerng nalyss ovember 7, 7 Outlne Revew stff equaton

More information

THE STURM-LIOUVILLE EIGENVALUE PROBLEM - A NUMERICAL SOLUTION USING THE CONTROL VOLUME METHOD

THE STURM-LIOUVILLE EIGENVALUE PROBLEM - A NUMERICAL SOLUTION USING THE CONTROL VOLUME METHOD Journal of Appled Mathematcs and Computatonal Mechancs 06, 5(), 7-36 www.amcm.pcz.pl p-iss 99-9965 DOI: 0.75/jamcm.06..4 e-iss 353-0588 THE STURM-LIOUVILLE EIGEVALUE PROBLEM - A UMERICAL SOLUTIO USIG THE

More information

Numerical Transient Heat Conduction Experiment

Numerical Transient Heat Conduction Experiment Numercal ransent Heat Conducton Experment OBJECIVE 1. o demonstrate the basc prncples of conducton heat transfer.. o show how the thermal conductvty of a sold can be measured. 3. o demonstrate the use

More information

1 GSW Iterative Techniques for y = Ax

1 GSW Iterative Techniques for y = Ax 1 for y = A I m gong to cheat here. here are a lot of teratve technques that can be used to solve the general case of a set of smultaneous equatons (wrtten n the matr form as y = A), but ths chapter sn

More information

Effects of Ignoring Correlations When Computing Sample Chi-Square. John W. Fowler February 26, 2012

Effects of Ignoring Correlations When Computing Sample Chi-Square. John W. Fowler February 26, 2012 Effects of Ignorng Correlatons When Computng Sample Ch-Square John W. Fowler February 6, 0 It can happen that ch-square must be computed for a sample whose elements are correlated to an unknown extent.

More information

3.1 Expectation of Functions of Several Random Variables. )' be a k-dimensional discrete or continuous random vector, with joint PMF p (, E X E X1 E X

3.1 Expectation of Functions of Several Random Variables. )' be a k-dimensional discrete or continuous random vector, with joint PMF p (, E X E X1 E X Statstcs 1: Probablty Theory II 37 3 EPECTATION OF SEVERAL RANDOM VARIABLES As n Probablty Theory I, the nterest n most stuatons les not on the actual dstrbuton of a random vector, but rather on a number

More information

Open Systems: Chemical Potential and Partial Molar Quantities Chemical Potential

Open Systems: Chemical Potential and Partial Molar Quantities Chemical Potential Open Systems: Chemcal Potental and Partal Molar Quanttes Chemcal Potental For closed systems, we have derved the followng relatonshps: du = TdS pdv dh = TdS + Vdp da = SdT pdv dg = VdP SdT For open systems,

More information

Army Ants Tunneling for Classical Simulations

Army Ants Tunneling for Classical Simulations Electronc Supplementary Materal (ESI) for Chemcal Scence. Ths journal s The Royal Socety of Chemstry 2014 electronc supplementary nformaton (ESI) for Chemcal Scence Army Ants Tunnelng for Classcal Smulatons

More information

A Functionally Fitted 3-stage ESDIRK Method Kazufumi Ozawa Akita Prefectural University Honjo Akita , Japan

A Functionally Fitted 3-stage ESDIRK Method Kazufumi Ozawa Akita Prefectural University Honjo Akita , Japan A Functonally Ftted 3-stage ESDIRK Method Kazufum Ozawa Akta Prefectural Unversty Hono Akta 05-0055, Japan ozawa@akta-pu.ac.p Abstract A specal class of Runge-Kutta (-Nyström) methods called functonally

More information

International Journal of Pure and Applied Sciences and Technology

International Journal of Pure and Applied Sciences and Technology Int. J. Pure Appl. Sc. Technol., 4() (03), pp. 5-30 Internatonal Journal of Pure and Appled Scences and Technology ISSN 9-607 Avalable onlne at www.jopaasat.n Research Paper Schrödnger State Space Matrx

More information

Canonical transformations

Canonical transformations Canoncal transformatons November 23, 2014 Recall that we have defned a symplectc transformaton to be any lnear transformaton M A B leavng the symplectc form nvarant, Ω AB M A CM B DΩ CD Coordnate transformatons,

More information

2.29 Numerical Fluid Mechanics

2.29 Numerical Fluid Mechanics REVIEW Lecture 10: Sprng 2015 Lecture 11 Classfcaton of Partal Dfferental Equatons PDEs) and eamples wth fnte dfference dscretzatons Parabolc PDEs Ellptc PDEs Hyperbolc PDEs Error Types and Dscretzaton

More information

2.3 Nilpotent endomorphisms

2.3 Nilpotent endomorphisms s a block dagonal matrx, wth A Mat dm U (C) In fact, we can assume that B = B 1 B k, wth B an ordered bass of U, and that A = [f U ] B, where f U : U U s the restrcton of f to U 40 23 Nlpotent endomorphsms

More information

1 Derivation of Point-to-Plane Minimization

1 Derivation of Point-to-Plane Minimization 1 Dervaton of Pont-to-Plane Mnmzaton Consder the Chen-Medon (pont-to-plane) framework for ICP. Assume we have a collecton of ponts (p, q ) wth normals n. We want to determne the optmal rotaton and translaton

More information

Suppose that there s a measured wndow of data fff k () ; :::; ff k g of a sze w, measured dscretely wth varable dscretzaton step. It s convenent to pl

Suppose that there s a measured wndow of data fff k () ; :::; ff k g of a sze w, measured dscretely wth varable dscretzaton step. It s convenent to pl RECURSIVE SPLINE INTERPOLATION METHOD FOR REAL TIME ENGINE CONTROL APPLICATIONS A. Stotsky Volvo Car Corporaton Engne Desgn and Development Dept. 97542, HA1N, SE- 405 31 Gothenburg Sweden. Emal: astotsky@volvocars.com

More information

Thermal-Fluids I. Chapter 18 Transient heat conduction. Dr. Primal Fernando Ph: (850)

Thermal-Fluids I. Chapter 18 Transient heat conduction. Dr. Primal Fernando Ph: (850) hermal-fluds I Chapter 18 ransent heat conducton Dr. Prmal Fernando prmal@eng.fsu.edu Ph: (850) 410-6323 1 ransent heat conducton In general, he temperature of a body vares wth tme as well as poston. In

More information

MTH 263 Practice Test #1 Spring 1999

MTH 263 Practice Test #1 Spring 1999 Pat Ross MTH 6 Practce Test # Sprng 999 Name. Fnd the area of the regon bounded by the graph r =acos (θ). Observe: Ths s a crcle of radus a, for r =acos (θ) r =a ³ x r r =ax x + y =ax x ax + y =0 x ax

More information

Integrals and Invariants of Euler-Lagrange Equations

Integrals and Invariants of Euler-Lagrange Equations Lecture 16 Integrals and Invarants of Euler-Lagrange Equatons ME 256 at the Indan Insttute of Scence, Bengaluru Varatonal Methods and Structural Optmzaton G. K. Ananthasuresh Professor, Mechancal Engneerng,

More information

Limited Dependent Variables

Limited Dependent Variables Lmted Dependent Varables. What f the left-hand sde varable s not a contnuous thng spread from mnus nfnty to plus nfnty? That s, gven a model = f (, β, ε, where a. s bounded below at zero, such as wages

More information

A New Refinement of Jacobi Method for Solution of Linear System Equations AX=b

A New Refinement of Jacobi Method for Solution of Linear System Equations AX=b Int J Contemp Math Scences, Vol 3, 28, no 17, 819-827 A New Refnement of Jacob Method for Soluton of Lnear System Equatons AX=b F Naem Dafchah Department of Mathematcs, Faculty of Scences Unversty of Gulan,

More information

Parametric fractional imputation for missing data analysis. Jae Kwang Kim Survey Working Group Seminar March 29, 2010

Parametric fractional imputation for missing data analysis. Jae Kwang Kim Survey Working Group Seminar March 29, 2010 Parametrc fractonal mputaton for mssng data analyss Jae Kwang Km Survey Workng Group Semnar March 29, 2010 1 Outlne Introducton Proposed method Fractonal mputaton Approxmaton Varance estmaton Multple mputaton

More information

2016 Wiley. Study Session 2: Ethical and Professional Standards Application

2016 Wiley. Study Session 2: Ethical and Professional Standards Application 6 Wley Study Sesson : Ethcal and Professonal Standards Applcaton LESSON : CORRECTION ANALYSIS Readng 9: Correlaton and Regresson LOS 9a: Calculate and nterpret a sample covarance and a sample correlaton

More information

Ballot Paths Avoiding Depth Zero Patterns

Ballot Paths Avoiding Depth Zero Patterns Ballot Paths Avodng Depth Zero Patterns Henrch Nederhausen and Shaun Sullvan Florda Atlantc Unversty, Boca Raton, Florda nederha@fauedu, ssull21@fauedu 1 Introducton In a paper by Sapounaks, Tasoulas,

More information