Bindel, Spring 2014 Applications of Parallel Computers (CS 5220)

Size: px
Start display at page:

Download "Bindel, Spring 2014 Applications of Parallel Computers (CS 5220)"

Transcription

1 Bndel, Sprng 2014 Applcatons of Parallel Computers (CS 5220) 1 Dervng SPH The Naver-Stokes equatons wth gravty are ρa = p + µ 2 v + ρg. The acceleraton s the materal dervatve of velocty, and we usually take an Euleran perspectve and wrte ths as a = Dv Dt = v t + v v. In smoothed partcle hydrodynamcs, though, we take a Lagrangan perspectve, and actually assocate computatonal partcles wth materal ponts. Ths makes t easy to deal wth the left-hand sde of the Naver-Stokes equaton. To compute the spatal dervatves on the rght hand sde of the equaton, we nterpolate pressures and veloctes at the materal partcles to get smoothed felds (hence the name). Then we dfferentate the smoothed felds. For example, suppose we care about some scalar feld A(r). Each partcle j has a mass, a locaton r j, and a value A j = A(r j ). Between partcles, we wrte (1) A S (r) = j A j W (r r j, h), where W s a smoothng kernel wth radus h. The denstes that appear n (1) are themselves are computed usng (1): ρ = ρ S (r ) = j W (r r j, h) = j W (r r j, h). Puttng everythng together, the SPH approxmaton computes feld quanttes at locatons assocated wth computatonal partcles. The governng equatons for the partcles and the assocated quanttes are then (2) (3) ρ a = f pressure f pressure = j + f vscosty + ρ g p + p j 2 W (r r j, h) (4) f vscosty = µ j v j v 2 W (r r j, h), where the pressure and vscous nteracton terms have been symmetrzed to ensure that partcle acts on partcle j n the same way j acts on. To compute the pressure, we use the deal gas equaton of state (5) p = k(ρ ρ 0 ). Of course, ths s not the rght equaton of state for a lqud! Ths equaton s best regarded as a non-physcal approxmaton that s legtmate as long as the artfcal speed of sound s much greater than the veloctes of nterest n the problem (as s the case wth the ncompressble approxmaton that s more commonly used n other settngs).

2 Bndel, Sprng 2014 Applcatons of Parallel Computers (CS 5220) 2 Smoothng kernels One of the key numercal decsons n SPH s the choce of kernels used to nterpolate the felds. We follow the strategy descrbed by Müller, Charypar, and Gross n Partcle-based flud smulaton for nteractve applcatons. In ths paper, the authors use three radally symmetrc dfferent kernels for 3D smulaton, each wth the form { W (r, h) = 1 f(q), 0 q 1 Ch d 0, otherwse where q = r/h = r /h and d = 3 s the dmenson. The kernels are based on the choces f poly6 (q) = (1 q 2 ) 3 for general nterpolaton, f spky (q) = (1 q) 3 for nterpolatng pressures, and f vscosty (q) = q 3 /2 + q 2 + q 1 /2 1 for vscosty computatons. The gradents are gven by and the Laplacans are 2 W (r, h) = W (r, h) = r Ch d+2 { q 1 f (q), 0 q 1 0, otherwse { 1 f (q) + (d 1)q 1 f (q), 0 q 1 Ch d+2 0, otherwse The pressure kernel s desgned wth relatvely steep gradents close to the orgn to prevent the clusterng of computatonal partcles that occurs when pressures are nterpolated wth W poly6. The vscosty kernel s desgned so that the Laplacan wll be postve defnte, ensurng that we don t accdentally get negatve vscous contrbutons that add energy to the system (and compromse stablty). 3 Condensed nteracton force expressons Makng thngs completely explct for the cases we care about most, we have (for 0 q 1) (6) (7) (8) (9) (10) W poly6 (r, h) = πh 3 (1 q2 ) 3 W poly6 (r, h) = πh 5 (1 q2 ) 2 r 2 W poly6 (r, h) = πh 5 (1 q2 )(7q 2 3) W spky (r, h) = 45 (1 q) 2 πh 5 r q 2 W vscosty (r, h) = 45 (1 q) πh5

3 Bndel, Sprng 2014 Applcatons of Parallel Computers (CS 5220) If we substtute (9), (10), and the equaton of state (5) nto (3) and (4), we have f pressure = 45k πh 5 f vscosty = 45µ πh 5 ρ + 2ρ 0 (1 q j ) 2 2 q j j N v v j (1 q j ) j N where N s the set of partcles wthn h of partcle and q j = r j /h, r j = r r j. Puttng these terms together, we have = where f pressure + f vscosty fj nteract = 45 [ k πh 5 (1 q j ) and v j = v v j. We then rewrte (2) as 4 Santy checks a = 1 ρ fj nteract j N r j 2 (ρ + 2ρ 0 ) (1 q j) r j µv j q j j + g. j N f nteract I farly regularly make typographcal and copyng errors when I do algebra and mplement t n code. In order to stay sane when I actually wrte somethng somewhat complcated, I fnd t helpful to put together lttle test scrpts to check my work numercally. For your edfcaton, n ths secton I gve my MATLAB test scrpt correspondng to the dervaton n these notes. The test scrpt s done n MATLAB. I begn by mplementng the functons f(q), the normalzng constants, and the kernel functons for each of the three kernels. fp6 (1-q.^2).^3; fsp (1-q).^3; fv q.^2-0.5*q.^ /q - 1; Cp6 = 64*p/315; Csp = p/15; Cv = 2*p/15; Wp6 1/Cp6/h^3 * fp6( norm(r)/h ); Wsp 1/Csp/h^3 * fsp( norm(r)/h ); Wv 1/Cv/h^3 * fv( norm(r)/h ); ], I computed the normalzaton constants analytcally, but I m prone to algebra mstakes when I compute ntegrals by hand. Let s check aganst MATLAB s quad functon.

4 Bndel, Sprng 2014 Applcatons of Parallel Computers (CS 5220) fprntf( Relerr for normalzaton constants:\n ); nerr_p6 = 4*p*q.^2.*fp6(q)/Cp6, 0, 1 ) - 1; nerr_sp = 4*p*q.^2.*fsp(q)/Csp, 0, 1 ) - 1; nerr_v = 4*p*q.^2.*fv(q)/Cv, 1e-12, 1 ) - 1; fprntf( Cp6: %g\n, nerr_p6); fprntf( Csp: %g\n, nerr_sp); fprntf( Cv: %g\n, nerr_v); Now check that I dd the calculus rght for the gradent and Laplacan of the W poly6 kernel, the gradent of the pressure kernel, and the Laplacan of the vscosty kernel h = rand(1); r = rand(3,1)*h/4; q = norm(r)/h; r2 = r *r; h2 = h^2; dr = norm(r)*1e-4; gwp6_fd = fd_grad(@(r) Wp6(r,h), r, dr); gwsp_fd = fd_grad(@(r) Wsp(r,h), r,dr); lwp6_fd = fd_laplace(@(r) Wp6(r,h), r, dr); lwv_fd = fd_laplace(@(r) Wv(r,h), r, dr); gwp6_ex = -(945/32/p)/h^5 *(1-q^2)^2 * r; gwsp_ex = -45/p/h^5*(1-q)^2/q * r; lwp6_ex = (945/32/p)/h^5 * (1-q^2)*(7*q^2-3); lwv_ex = 45/p/h^5 * (1-q); fprntf( Check kernel dervatves:\n ); fprntf( grad Wp6: %g\n, norm(gwp6_fd-gwp6_ex)/norm(gwp6_ex)); fprntf( grad Wsp: %g\n, norm(gwsp_fd-gwsp_ex)/norm(gwsp_ex)); fprntf( lapl Wp6: %g\n, (lwp6_fd-lwp6_ex)/lwp6_ex); fprntf( lapl Wv: %g\n, (lwv_fd-lwv_ex)/lwv_ex); Now check that f vscosty (q) satsfes the boundary condtons f(1) = 0 f (1) = 0 The frst two condtons we check drectly. dq = 1e-4; fprntf( Relerr for vscosty kernel checks:\n );

5 Bndel, Sprng 2014 Applcatons of Parallel Computers (CS 5220) fprntf( fv (1): %g\n, fv(1) ); fprntf( dfv(1): %g\n, fd_derv(fv,1,dq) ); Now, let me check that I dd the algebra rght n gettng the condensed formula for the nteracton forces. % Set up random parameter choces r_j = rand(3,1); v_j = rand(3,1); k = rand(1); rho0 = rand(1); rho = rand(1); rhoj = rand(1); mass = rand(1); mu = rand(1); q = norm(r_j)/h; % Compute pressures va equaton of state P = k*(rho-rho0); Pj = k*(rhoj-rho0); % Dfferentate the kernels Wsp_x = -45/p/h^5*(1-q)^2/q * r_j; LWv = 45/p/h^5*(1-q); % Do the straghtforward computaton fpressure = -mass*(p+pj)/2/rhoj * Wsp_x; fvscous = -mu*mass*v_j/rhoj * LWv; fnteract1 = fpressure + fvscous; % Do the computaton based on my condensed formula fnteract2 = 45*mass/p/h^5/rhoj * (1-q) *... ( k/2*(rho+rhoj-2*rho0)*(1-q)/q * r_j - mu * v_j ); % Compare fprntf( Relerr n nteracton force check:\n ); fprntf( fnt: %g\n, norm(fnteract1-fnteract2)/norm(fnteract1)); Of course, all the above s supported by a number of lttle second-order accurate fnte dfference calculatons. functon fp = fd_derv(f,r,h)

6 Bndel, Sprng 2014 Applcatons of Parallel Computers (CS 5220) fp = ( f(r+h)-f(r-h) )/2/h; functon fpp = fd_derv2(f,r,h) fpp = ( f(r+h)-2*f(r)+f(r-h) )/h/h; functon del2f = fd_laplace_radal(f,r,h) del2f = fd_derv2(f,r,h) + 2*fd_derv(f,r,h)/r; functon del2f = fd_laplace(f,r,h) e1 = [1; 0; 0]; e2 = [0; 1; 0]; e3 = [0; 0; 1]; del2f = (-6*f(r)+... f(r+h*e1)+f(r+h*e2)+f(r+h*e3)+... f(r-h*e1)+f(r-h*e2)+f(r-h*e3) )/h/h; functon gradf = fd_grad(f,r,h) e1 = [1; 0; 0]; e2 = [0; 1; 0]; e3 = [0; 0; 1]; gradf = [f(r+h*e1)-f(r-h*e1); f(r+h*e2)-f(r-h*e2); f(r+h*e3)-f(r-h*e3)] / 2 / h;

arxiv: v1 [physics.flu-dyn] 16 Sep 2013

arxiv: v1 [physics.flu-dyn] 16 Sep 2013 Three-Dmensonal Smoothed Partcle Hydrodynamcs Method for Smulatng Free Surface Flows Rzal Dw Prayogo a,b, Chrstan Fredy Naa a a Faculty of Mathematcs and Natural Scences, Insttut Teknolog Bandung, Jl.

More information

Computational Fluid Dynamics. Smoothed Particle Hydrodynamics. Simulations. Smoothing Kernels and Basis of SPH

Computational Fluid Dynamics. Smoothed Particle Hydrodynamics. Simulations. Smoothing Kernels and Basis of SPH Computatonal Flud Dynamcs If you want to learn a bt more of the math behnd flud dynamcs, read my prevous post about the Naver- Stokes equatons and Newtonan fluds. The equatons derved n the post are the

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

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

ELASTIC WAVE PROPAGATION IN A CONTINUOUS MEDIUM

ELASTIC WAVE PROPAGATION IN A CONTINUOUS MEDIUM ELASTIC WAVE PROPAGATION IN A CONTINUOUS MEDIUM An elastc wave s a deformaton of the body that travels throughout the body n all drectons. We can examne the deformaton over a perod of tme by fxng our look

More information

Week3, Chapter 4. Position and Displacement. Motion in Two Dimensions. Instantaneous Velocity. Average Velocity

Week3, Chapter 4. Position and Displacement. Motion in Two Dimensions. Instantaneous Velocity. Average Velocity Week3, Chapter 4 Moton n Two Dmensons Lecture Quz A partcle confned to moton along the x axs moves wth constant acceleraton from x =.0 m to x = 8.0 m durng a 1-s tme nterval. The velocty of the partcle

More information

Lecture 20: Noether s Theorem

Lecture 20: Noether s Theorem Lecture 20: Noether s Theorem In our revew of Newtonan Mechancs, we were remnded that some quanttes (energy, lnear momentum, and angular momentum) are conserved That s, they are constant f no external

More information

Tensor Smooth Length for SPH Modelling of High Speed Impact

Tensor Smooth Length for SPH Modelling of High Speed Impact Tensor Smooth Length for SPH Modellng of Hgh Speed Impact Roman Cherepanov and Alexander Gerasmov Insttute of Appled mathematcs and mechancs, Tomsk State Unversty 634050, Lenna av. 36, Tomsk, Russa RCherepanov82@gmal.com,Ger@npmm.tsu.ru

More information

Week 9 Chapter 10 Section 1-5

Week 9 Chapter 10 Section 1-5 Week 9 Chapter 10 Secton 1-5 Rotaton Rgd Object A rgd object s one that s nondeformable The relatve locatons of all partcles makng up the object reman constant All real objects are deformable to some extent,

More information

THE VIBRATIONS OF MOLECULES II THE CARBON DIOXIDE MOLECULE Student Instructions

THE VIBRATIONS OF MOLECULES II THE CARBON DIOXIDE MOLECULE Student Instructions THE VIBRATIONS OF MOLECULES II THE CARBON DIOXIDE MOLECULE Student Instructons by George Hardgrove Chemstry Department St. Olaf College Northfeld, MN 55057 hardgrov@lars.acc.stolaf.edu Copyrght George

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

Module 1 : The equation of continuity. Lecture 1: Equation of Continuity

Module 1 : The equation of continuity. Lecture 1: Equation of Continuity 1 Module 1 : The equaton of contnuty Lecture 1: Equaton of Contnuty 2 Advanced Heat and Mass Transfer: Modules 1. THE EQUATION OF CONTINUITY : Lectures 1-6 () () () (v) (v) Overall Mass Balance Momentum

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

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

PHYS 705: Classical Mechanics. Newtonian Mechanics

PHYS 705: Classical Mechanics. Newtonian Mechanics 1 PHYS 705: Classcal Mechancs Newtonan Mechancs Quck Revew of Newtonan Mechancs Basc Descrpton: -An dealzed pont partcle or a system of pont partcles n an nertal reference frame [Rgd bodes (ch. 5 later)]

More information

Physics 181. Particle Systems

Physics 181. Particle Systems Physcs 181 Partcle Systems Overvew In these notes we dscuss the varables approprate to the descrpton of systems of partcles, ther defntons, ther relatons, and ther conservatons laws. We consder a system

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

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

NMT EE 589 & UNM ME 482/582 ROBOT ENGINEERING. Dr. Stephen Bruder NMT EE 589 & UNM ME 482/582

NMT EE 589 & UNM ME 482/582 ROBOT ENGINEERING. Dr. Stephen Bruder NMT EE 589 & UNM ME 482/582 NMT EE 589 & UNM ME 48/58 ROBOT ENGINEERING Dr. Stephen Bruder NMT EE 589 & UNM ME 48/58 7. Robot Dynamcs 7.5 The Equatons of Moton Gven that we wsh to fnd the path q(t (n jont space) whch mnmzes the energy

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

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

coordinates. Then, the position vectors are described by

coordinates. Then, the position vectors are described by Revewng, what we have dscussed so far: Generalzed coordnates Any number of varables (say, n) suffcent to specfy the confguraton of the system at each nstant to tme (need not be the mnmum number). In general,

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

(δr i ) 2. V i. r i 2,

(δr i ) 2. V i. r i 2, Cartesan coordnates r, = 1, 2,... D for Eucldean space. Dstance by Pythagoras: (δs 2 = (δr 2. Unt vectors ê, dsplacement r = r ê Felds are functons of poston, or of r or of {r }. Scalar felds Φ( r, Vector

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

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 6

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 6 REVIEW of Lecture 5 2.29 Numercal Flud Mechancs Fall 2011 Lecture 6 Contnuum Hypothess and conservaton laws Macroscopc Propertes Materal covered n class: Dfferental forms of conservaton laws Materal Dervatve

More information

Implicit Integration Henyey Method

Implicit Integration Henyey Method Implct Integraton Henyey Method In realstc stellar evoluton codes nstead of a drect ntegraton usng for example the Runge-Kutta method one employs an teratve mplct technque. Ths s because the structure

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

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

CONTROLLED FLOW SIMULATION USING SPH METHOD

CONTROLLED FLOW SIMULATION USING SPH METHOD HERI COADA AIR FORCE ACADEMY ROMAIA ITERATIOAL COFERECE of SCIETIFIC PAPER AFASES 01 Brasov, 4-6 May 01 GEERAL M.R. STEFAIK ARMED FORCES ACADEMY SLOVAK REPUBLIC COTROLLED FLOW SIMULATIO USIG SPH METHOD

More information

Classical Field Theory

Classical Field Theory Classcal Feld Theory Before we embark on quantzng an nteractng theory, we wll take a dverson nto classcal feld theory and classcal perturbaton theory and see how far we can get. The reader s expected to

More information

(Online First)A Lattice Boltzmann Scheme for Diffusion Equation in Spherical Coordinate

(Online First)A Lattice Boltzmann Scheme for Diffusion Equation in Spherical Coordinate Internatonal Journal of Mathematcs and Systems Scence (018) Volume 1 do:10.494/jmss.v1.815 (Onlne Frst)A Lattce Boltzmann Scheme for Dffuson Equaton n Sphercal Coordnate Debabrata Datta 1 *, T K Pal 1

More information

NUMERICAL MODEL FOR NON-DARCY FLOW THROUGH COARSE POROUS MEDIA USING THE MOVING PARTICLE SIMULATION METHOD

NUMERICAL MODEL FOR NON-DARCY FLOW THROUGH COARSE POROUS MEDIA USING THE MOVING PARTICLE SIMULATION METHOD THERMAL SCIENCE: Year 2018, Vol. 22, No. 5, pp. 1955-1962 1955 NUMERICAL MODEL FOR NON-DARCY FLOW THROUGH COARSE POROUS MEDIA USING THE MOVING PARTICLE SIMULATION METHOD Introducton by Tomok IZUMI a* and

More information

Homogeneous model: Horizontal pipe and horizontal well. Flow loops can't duplicate field conditions. Daniel D. Joseph. April 2001

Homogeneous model: Horizontal pipe and horizontal well. Flow loops can't duplicate field conditions. Daniel D. Joseph. April 2001 Homogeneous model of producton of heavy ol through horzontal ppelnes and wells based on the Naver-Stokes equatons n the ppelne or the well and Darcy's law n the reservor Homogeneous model: Danel D. Joseph

More information

Ahmad Shakibaeinia Assistant Professor Department of Civil, Geological & Mining Engineering Polytechnique Montreal

Ahmad Shakibaeinia Assistant Professor Department of Civil, Geological & Mining Engineering Polytechnique Montreal Natonal Center for Atmospherc Research (NCAR) IMAGe TOY2017: Workshop on Multscale Geoscence Numercs Ahmad Shakbaena Assstant Professor Department of Cvl, Geologcal & Mnng Engneerng Polytechnque Montreal

More information

PES 1120 Spring 2014, Spendier Lecture 6/Page 1

PES 1120 Spring 2014, Spendier Lecture 6/Page 1 PES 110 Sprng 014, Spender Lecture 6/Page 1 Lecture today: Chapter 1) Electrc feld due to charge dstrbutons -> charged rod -> charged rng We ntroduced the electrc feld, E. I defned t as an nvsble aura

More information

Application of B-Spline to Numerical Solution of a System of Singularly Perturbed Problems

Application of B-Spline to Numerical Solution of a System of Singularly Perturbed Problems Mathematca Aeterna, Vol. 1, 011, no. 06, 405 415 Applcaton of B-Splne to Numercal Soluton of a System of Sngularly Perturbed Problems Yogesh Gupta Department of Mathematcs Unted College of Engneerng &

More information

Math1110 (Spring 2009) Prelim 3 - Solutions

Math1110 (Spring 2009) Prelim 3 - Solutions Math 1110 (Sprng 2009) Solutons to Prelm 3 (04/21/2009) 1 Queston 1. (16 ponts) Short answer. Math1110 (Sprng 2009) Prelm 3 - Solutons x a 1 (a) (4 ponts) Please evaluate lm, where a and b are postve numbers.

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

Solutions for Euler and Navier-Stokes Equations in Powers of Time

Solutions for Euler and Navier-Stokes Equations in Powers of Time Solutons for Euler and Naver-Stokes Equatons n Powers of Tme Valdr Montero dos Santos Godo valdr.msgodo@gmal.com Abstract We present a soluton for the Euler and Naver-Stokes equatons for ncompressble case

More information

χ x B E (c) Figure 2.1.1: (a) a material particle in a body, (b) a place in space, (c) a configuration of the body

χ x B E (c) Figure 2.1.1: (a) a material particle in a body, (b) a place in space, (c) a configuration of the body Secton.. Moton.. The Materal Body and Moton hyscal materals n the real world are modeled usng an abstract mathematcal entty called a body. Ths body conssts of an nfnte number of materal partcles. Shown

More information

Section 8.3 Polar Form of Complex Numbers

Section 8.3 Polar Form of Complex Numbers 80 Chapter 8 Secton 8 Polar Form of Complex Numbers From prevous classes, you may have encountered magnary numbers the square roots of negatve numbers and, more generally, complex numbers whch are the

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

One Dimension Again. Chapter Fourteen

One Dimension Again. Chapter Fourteen hapter Fourteen One Dmenson Agan 4 Scalar Lne Integrals Now we agan consder the dea of the ntegral n one dmenson When we were ntroduced to the ntegral back n elementary school, we consdered only functons

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

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

ACTM State Calculus Competition Saturday April 30, 2011

ACTM State Calculus Competition Saturday April 30, 2011 ACTM State Calculus Competton Saturday Aprl 30, 2011 ACTM State Calculus Competton Sprng 2011 Page 1 Instructons: For questons 1 through 25, mark the best answer choce on the answer sheet provde Afterward

More information

Buckingham s pi-theorem

Buckingham s pi-theorem TMA495 Mathematcal modellng 2004 Buckngham s p-theorem Harald Hanche-Olsen hanche@math.ntnu.no Theory Ths note s about physcal quanttes R,...,R n. We lke to measure them n a consstent system of unts, such

More information

U.C. Berkeley CS294: Beyond Worst-Case Analysis Luca Trevisan September 5, 2017

U.C. Berkeley CS294: Beyond Worst-Case Analysis Luca Trevisan September 5, 2017 U.C. Berkeley CS94: Beyond Worst-Case Analyss Handout 4s Luca Trevsan September 5, 07 Summary of Lecture 4 In whch we ntroduce semdefnte programmng and apply t to Max Cut. Semdefnte Programmng Recall that

More information

Work is the change in energy of a system (neglecting heat transfer). To examine what could

Work is the change in energy of a system (neglecting heat transfer). To examine what could Work Work s the change n energy o a system (neglectng heat transer). To eamne what could cause work, let s look at the dmensons o energy: L ML E M L F L so T T dmensonally energy s equal to a orce tmes

More information

Three views of mechanics

Three views of mechanics Three vews of mechancs John Hubbard, n L. Gross s course February 1, 211 1 Introducton A mechancal system s manfold wth a Remannan metrc K : T M R called knetc energy and a functon V : M R called potental

More information

Extension of Smoothed Particle Hydrodynamics (SPH), Mathematical Background of Vortex Blob Method (VBM) and Moving Particle Semi-Implicit (MPS)

Extension of Smoothed Particle Hydrodynamics (SPH), Mathematical Background of Vortex Blob Method (VBM) and Moving Particle Semi-Implicit (MPS) Amercan Journal of Computatonal athematcs, 04, 5, 44-445 Publshed Onlne December 04 n ScRes. http://www.scrp.org/ournal/acm http://dx.do.org/0.436/acm.04.45036 Extenson of Smoothed Partcle Hydrodynamcs

More information

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

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

Mechanics Physics 151

Mechanics Physics 151 Mechancs Physcs 151 Lecture 3 Lagrange s Equatons (Goldsten Chapter 1) Hamlton s Prncple (Chapter 2) What We Dd Last Tme! Dscussed mult-partcle systems! Internal and external forces! Laws of acton and

More information

CSci 6974 and ECSE 6966 Math. Tech. for Vision, Graphics and Robotics Lecture 21, April 17, 2006 Estimating A Plane Homography

CSci 6974 and ECSE 6966 Math. Tech. for Vision, Graphics and Robotics Lecture 21, April 17, 2006 Estimating A Plane Homography CSc 6974 and ECSE 6966 Math. Tech. for Vson, Graphcs and Robotcs Lecture 21, Aprl 17, 2006 Estmatng A Plane Homography Overvew We contnue wth a dscusson of the major ssues, usng estmaton of plane projectve

More information

Smoothed particle hydrodynamics modelling of fluids and solids

Smoothed particle hydrodynamics modelling of fluids and solids Appled and Computatonal Mechancs 1 (2007) 521-530 Smoothed partcle hydrodynamcs modellng of fluds and solds L. Lobovský a,, J. Křen a a Department of Mechancs, Faculty of Appled Scences, UWB n Plsen, Unverztní

More information

A new integrated-rbf-based domain-embedding scheme for solving fluid-flow problems

A new integrated-rbf-based domain-embedding scheme for solving fluid-flow problems Home Search Collectons Journals About Contact us My IOPscence A new ntegrated-rbf-based doman-embeddng scheme for solvng flud-flow problems Ths artcle has been downloaded from IOPscence. Please scroll

More information

8.022 (E&M) Lecture 4

8.022 (E&M) Lecture 4 Topcs: 8.0 (E&M) Lecture 4 More applcatons of vector calculus to electrostatcs: Laplacan: Posson and Laplace equaton url: concept and applcatons to electrostatcs Introducton to conductors Last tme Electrc

More information

Report on Image warping

Report on Image warping Report on Image warpng Xuan Ne, Dec. 20, 2004 Ths document summarzed the algorthms of our mage warpng soluton for further study, and there s a detaled descrpton about the mplementaton of these algorthms.

More information

Moments of Inertia. and reminds us of the analogous equation for linear momentum p= mv, which is of the form. The kinetic energy of the body is.

Moments of Inertia. and reminds us of the analogous equation for linear momentum p= mv, which is of the form. The kinetic energy of the body is. Moments of Inerta Suppose a body s movng on a crcular path wth constant speed Let s consder two quanttes: the body s angular momentum L about the center of the crcle, and ts knetc energy T How are these

More information

Lossy Compression. Compromise accuracy of reconstruction for increased compression.

Lossy Compression. Compromise accuracy of reconstruction for increased compression. Lossy Compresson Compromse accuracy of reconstructon for ncreased compresson. The reconstructon s usually vsbly ndstngushable from the orgnal mage. Typcally, one can get up to 0:1 compresson wth almost

More information

Celestial Mechanics. Basic Orbits. Why circles? Tycho Brahe. PHY celestial-mechanics - J. Hedberg

Celestial Mechanics. Basic Orbits. Why circles? Tycho Brahe. PHY celestial-mechanics - J. Hedberg PHY 454 - celestal-mechancs - J. Hedberg - 207 Celestal Mechancs. Basc Orbts. Why crcles? 2. Tycho Brahe 3. Kepler 4. 3 laws of orbtng bodes 2. Newtonan Mechancs 3. Newton's Laws. Law of Gravtaton 2. The

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

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

8.323 Relativistic Quantum Field Theory I

8.323 Relativistic Quantum Field Theory I MI OpenCourseWare http://ocw.mt.edu 8.323 Relatvstc Quantum Feld heory I Sprng 2008 For nformaton about ctng these materals or our erms of Use, vst: http://ocw.mt.edu/terms. MASSACHUSES INSIUE OF ECHNOLOGY

More information

Turbulent Transport in Single-Phase Flow. Peter Bernard, University of Maryland

Turbulent Transport in Single-Phase Flow. Peter Bernard, University of Maryland Turbulent Transport n Sngle-Phase Flow Peter Bernard, Unversty of Maryland Assume that our goal s to compute mean flow statstcs such as U and One can ether: 1 u where U Pursue DNS (.e. the "honest" approach)

More information

Adjoint Methods of Sensitivity Analysis for Lyapunov Equation. Boping Wang 1, Kun Yan 2. University of Technology, Dalian , P. R.

Adjoint Methods of Sensitivity Analysis for Lyapunov Equation. Boping Wang 1, Kun Yan 2. University of Technology, Dalian , P. R. th World Congress on Structural and Multdscplnary Optmsaton 7 th - th, June 5, Sydney Australa Adjont Methods of Senstvty Analyss for Lyapunov Equaton Bopng Wang, Kun Yan Department of Mechancal and Aerospace

More information

Airflow and Contaminant Simulation with CONTAM

Airflow and Contaminant Simulation with CONTAM Arflow and Contamnant Smulaton wth CONTAM George Walton, NIST CHAMPS Developers Workshop Syracuse Unversty June 19, 2006 Network Analogy Electrc Ppe, Duct & Ar Wre Ppe, Duct, or Openng Juncton Juncton

More information

Physics 53. Rotational Motion 3. Sir, I have found you an argument, but I am not obliged to find you an understanding.

Physics 53. Rotational Motion 3. Sir, I have found you an argument, but I am not obliged to find you an understanding. Physcs 53 Rotatonal Moton 3 Sr, I have found you an argument, but I am not oblged to fnd you an understandng. Samuel Johnson Angular momentum Wth respect to rotatonal moton of a body, moment of nerta plays

More information

Computational Geodynamics: Advection equations and the art of numerical modeling

Computational Geodynamics: Advection equations and the art of numerical modeling 540 Geodynamcs Unversty of Southern Calforna, Los Angeles Computatonal Geodynamcs: Advecton equatons and the art of numercal modelng Sofar we manly focussed on dffuson equaton n a non-movng doman. Ths

More information

Temperature. Chapter Heat Engine

Temperature. Chapter Heat Engine Chapter 3 Temperature In prevous chapters of these notes we ntroduced the Prncple of Maxmum ntropy as a technque for estmatng probablty dstrbutons consstent wth constrants. In Chapter 9 we dscussed the

More information

From Biot-Savart Law to Divergence of B (1)

From Biot-Savart Law to Divergence of B (1) From Bot-Savart Law to Dvergence of B (1) Let s prove that Bot-Savart gves us B (r ) = 0 for an arbtrary current densty. Frst take the dvergence of both sdes of Bot-Savart. The dervatve s wth respect to

More information

Kinematics of Fluids. Lecture 16. (Refer the text book CONTINUUM MECHANICS by GEORGE E. MASE, Schaum s Outlines) 17/02/2017

Kinematics of Fluids. Lecture 16. (Refer the text book CONTINUUM MECHANICS by GEORGE E. MASE, Schaum s Outlines) 17/02/2017 17/0/017 Lecture 16 (Refer the text boo CONTINUUM MECHANICS by GEORGE E. MASE, Schaum s Outlnes) Knematcs of Fluds Last class, we started dscussng about the nematcs of fluds. Recall the Lagrangan and Euleran

More information

Introduction to Computational Fluid Dynamics

Introduction to Computational Fluid Dynamics Introducton to Computatonal Flud Dynamcs M. Zanub 1, T. Mahalakshm 2 1 (PG MATHS), Department of Mathematcs, St. Josephs College of Arts and Scence for Women-Hosur, Peryar Unversty 2 Assstance professor,

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

Computational Astrophysics

Computational Astrophysics Computatonal Astrophyscs Solvng for Gravty Alexander Knebe, Unversdad Autonoma de Madrd Computatonal Astrophyscs Solvng for Gravty the equatons full set of equatons collsonless matter (e.g. dark matter

More information

Topic 5: Non-Linear Regression

Topic 5: Non-Linear Regression Topc 5: Non-Lnear Regresson The models we ve worked wth so far have been lnear n the parameters. They ve been of the form: y = Xβ + ε Many models based on economc theory are actually non-lnear n the parameters.

More information

Flow Induced Vibration

Flow Induced Vibration Flow Induced Vbraton Project Progress Report Date: 16 th November, 2005 Submtted by Subhrajt Bhattacharya Roll no.: 02ME101 Done under the gudance of Prof. Anrvan Dasgupta Department of Mechancal Engneerng,

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

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

Causal Diamonds. M. Aghili, L. Bombelli, B. Pilgrim

Causal Diamonds. M. Aghili, L. Bombelli, B. Pilgrim Causal Damonds M. Aghl, L. Bombell, B. Plgrm Introducton The correcton to volume of a causal nterval due to curvature of spacetme has been done by Myrhem [] and recently by Gbbons & Solodukhn [] and later

More information

Conservation of Angular Momentum = "Spin"

Conservation of Angular Momentum = Spin Page 1 of 6 Conservaton of Angular Momentum = "Spn" We can assgn a drecton to the angular velocty: drecton of = drecton of axs + rght hand rule (wth rght hand, curl fngers n drecton of rotaton, thumb ponts

More information

Kernel Methods and SVMs Extension

Kernel Methods and SVMs Extension Kernel Methods and SVMs Extenson The purpose of ths document s to revew materal covered n Machne Learnng 1 Supervsed Learnng regardng support vector machnes (SVMs). Ths document also provdes a general

More information

THE CHINESE REMAINDER THEOREM. We should thank the Chinese for their wonderful remainder theorem. Glenn Stevens

THE CHINESE REMAINDER THEOREM. We should thank the Chinese for their wonderful remainder theorem. Glenn Stevens THE CHINESE REMAINDER THEOREM KEITH CONRAD We should thank the Chnese for ther wonderful remander theorem. Glenn Stevens 1. Introducton The Chnese remander theorem says we can unquely solve any par of

More information

Solution of the Navier-Stokes Equations

Solution of the Navier-Stokes Equations Numercal Flud Mechancs Fall 2011 Lecture 25 REVIEW Lecture 24: Soluton of the Naver-Stokes Equatons Dscretzaton of the convectve and vscous terms Dscretzaton of the pressure term Conservaton prncples Momentum

More information

The Governing Equations

The Governing Equations The Governng Equatons L. Goodman General Physcal Oceanography MAR 555 School for Marne Scences and Technology Umass-Dartmouth Dynamcs of Oceanography The Governng Equatons- (IPO-7) Mass Conservaton and

More information

Chapter 4 The Wave Equation

Chapter 4 The Wave Equation Chapter 4 The Wave Equaton Another classcal example of a hyperbolc PDE s a wave equaton. The wave equaton s a second-order lnear hyperbolc PDE that descrbes the propagaton of a varety of waves, such as

More information

In this section is given an overview of the common elasticity models.

In this section is given an overview of the common elasticity models. Secton 4.1 4.1 Elastc Solds In ths secton s gven an overvew of the common elastcty models. 4.1.1 The Lnear Elastc Sold The classcal Lnear Elastc model, or Hooean model, has the followng lnear relatonshp

More information

THEOREMS OF QUANTUM MECHANICS

THEOREMS OF QUANTUM MECHANICS THEOREMS OF QUANTUM MECHANICS In order to develop methods to treat many-electron systems (atoms & molecules), many of the theorems of quantum mechancs are useful. Useful Notaton The matrx element A mn

More information

CHAPTER 5: Lie Differentiation and Angular Momentum

CHAPTER 5: Lie Differentiation and Angular Momentum CHAPTER 5: Le Dfferentaton and Angular Momentum Jose G. Vargas 1 Le dfferentaton Kähler s theory of angular momentum s a specalzaton of hs approach to Le dfferentaton. We could deal wth the former drectly,

More information

Lagrange Multipliers. A Somewhat Silly Example. Monday, 25 September 2013

Lagrange Multipliers. A Somewhat Silly Example. Monday, 25 September 2013 Lagrange Multplers Monday, 5 September 013 Sometmes t s convenent to use redundant coordnates, and to effect the varaton of the acton consstent wth the constrants va the method of Lagrange undetermned

More information

Physics 2A Chapters 6 - Work & Energy Fall 2017

Physics 2A Chapters 6 - Work & Energy Fall 2017 Physcs A Chapters 6 - Work & Energy Fall 017 These notes are eght pages. A quck summary: The work-energy theorem s a combnaton o Chap and Chap 4 equatons. Work s dened as the product o the orce actng on

More information

ANSWERS. Problem 1. and the moment generating function (mgf) by. defined for any real t. Use this to show that E( U) var( U)

ANSWERS. Problem 1. and the moment generating function (mgf) by. defined for any real t. Use this to show that E( U) var( U) Econ 413 Exam 13 H ANSWERS Settet er nndelt 9 deloppgaver, A,B,C, som alle anbefales å telle lkt for å gøre det ltt lettere å stå. Svar er gtt . Unfortunately, there s a prntng error n the hnt of

More information

Some notes on Futaki invariant

Some notes on Futaki invariant Some notes on Futak nvarant Ch L Analytc Defnton of Futak Invarant Let be an n dmensonal normal varety. Assume t s Fano,.e. ts antcanoncal lne bundle K s ample. If s smooth, then for any Kähler form ω

More information

Chapter 3. r r. Position, Velocity, and Acceleration Revisited

Chapter 3. r r. Position, Velocity, and Acceleration Revisited Chapter 3 Poston, Velocty, and Acceleraton Revsted The poston vector of a partcle s a vector drawn from the orgn to the locaton of the partcle. In two dmensons: r = x ˆ+ yj ˆ (1) The dsplacement vector

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

Optimal Control of Temperature in Fluid Flow

Optimal Control of Temperature in Fluid Flow Kawahara Lab. 5 March. 27 Optmal Control of Temperature n Flud Flow Dasuke YAMAZAKI Department of Cvl Engneerng, Chuo Unversty Kasuga -3-27, Bunkyou-ku, Tokyo 2-855, Japan E-mal : d33422@educ.kc.chuo-u.ac.jp

More information

Interconnect Modeling

Interconnect Modeling Interconnect Modelng Modelng of Interconnects Interconnect R, C and computaton Interconnect models umped RC model Dstrbuted crcut models Hgher-order waveform n dstrbuted RC trees Accuracy and fdelty Prepared

More information

Advanced Circuits Topics - Part 1 by Dr. Colton (Fall 2017)

Advanced Circuits Topics - Part 1 by Dr. Colton (Fall 2017) Advanced rcuts Topcs - Part by Dr. olton (Fall 07) Part : Some thngs you should already know from Physcs 0 and 45 These are all thngs that you should have learned n Physcs 0 and/or 45. Ths secton s organzed

More information