New Streamfunction Approach for Magnetohydrodynamics

Size: px
Start display at page:

Download "New Streamfunction Approach for Magnetohydrodynamics"

Transcription

1 New Streamfunction Approac for Magnetoydrodynamics Kab Seo Kang Brooaven National Laboratory, Computational Science Center, Building 63, Room, Upton NY 973, USA. Summary. We apply te finite element metod to two-dimensional, incompressible MHD, using a streamfunction approac to enforce te divergence-free conditions on te magnetic and velocity fields. Tis problem was considered by Strauss and Longcope [SL9]. In tis paper, we solve te problems wit magnetic and velocity fields instead of te velocity stream function, magnetic flux, and teir derivatives. Considering te multiscale nature of te tilt instability, we study te effect of domain resolution in te tilt instability problem. We use a finite element discretization on unstructured meses and an implicit sceme. We use te PETSc library wit index sets for parallelization. To solve te nonlinear MHD problem, we compare two nonlinear Gauss-Seidel type metods and Newton s metod wit several time step sizes. We use GMRES in PETSc wit multigrid preconditioning to solve te linear subproblems witin te nonlinear solvers. We also study te scalability of tis program on a cluster. MHD and its streamfunction approac Magnetoydrodynamics (MHD) is te fluid dynamics of conducting fluid or plasma, coupled wit Maxwell s equations. Te fluid motion induces currents, wic produce Lorentz body forces on te fluid. Ampere s law relates te currents to te magnetic field. Te MHD approximation is tat te electric field vanises in te moving fluid frame, except for possible resistive effects. In tis study, we consider finite element metods on an unstructured mes for two-dimensional, incompressible MHD, using a streamfunction approac to enforce te divergence-free condition on magnetic and velocity fields and an implicit time difference sceme to allow muc lager time steps. Strauss and Longcope [SL9] applied adaptive finite element metod wit explicit time difference sceme to tis problem. Te incompressible MHD equations are: t B = (v B), v =, B =, t v = v v + ( B) B + µ v, ()

2 Kab Seo Kang were B is te magnetic field, v is te velocity, and µ is te viscosity. To enforce ( incompressibility, ) ( it is) common to introduce stream functions: v = φ y, φ, B = ψ y, ψ. By reformulation for symmetric treatment of te fields, in te sense tat te source function Ω and C are time advanced, and te potentials φ and ψ are obtained at eac time step by solving Poisson equations, we obtain t Ω + [Ω, φ] = [C, ψ] + µ Ω, [ t C + [C, φ] = [Ω, ψ] + φ, ψ φ = Ω, ψ = C, ] [ ] + φ y, ψ y () b y a b were [a, b] = a y. To solve (), we ave to compute te partial derivatives of potentials. Tese partial derivatives can be obtained by solutions of linear problems. To do tis, we ave to introduce four auxiliary variables. It requires te solution of eigt equations at eac step. We use te velocity v and te magnetic field B to reduce ( te number ) of equations to solve (). To tis aim, we put v = (v, v ) = φ y, φ, B = ( ) (B, B ) = ψ y, ψ in equation () and get te following system: Ω t + (v, v ) Ω = (B, B ) C + µ Ω, C t + (v, v ) C = (B, B ) Ω + ([v, B ] + [v, B ]), v = Ω y, v = Ω, B = C y, B = C φ = Ω, ψ = C., (3) In te eigt equations in (3), te last two equations for potentials don t need to be solved to get te solutions in eac time step. If te potentials are needed at a specific time, tey are obtained by solving te last two equations in (3). To solve te Poisson s equations for v and B in (3), we ave to impose boundary conditions wic are compatible to boundary conditions of φ, ψ, Ω, and C. Finite discretization To solve (3), we use te first-order bacward difference (Euler) derivative sceme leading to an implicit sceme wic removes te numerically imposed time-step constraint, allowing muc larger time steps. Tis approac is first order accurate in time and is cosen merely for convenience. Let H denote H (K), H,A denote te subset of H (K) wic satisfy te boundary condition of A, and H,A denote e subspace of H (K) wose elements ave zero values on te Diriclet boundary of A = Ω, v, v, B, B. Multiply te test functions and integrate by parts in eac equation and use te appropriate boundary conditions, to derive te variational form of (3) as

3 New Streamfunction Approac for Magnetoydrodynamics 3 follows: Find X = (Ω, C, v, v, B, B ) H,Ω H H,v H,v H,B H,B suc tat F n (X,Y) = () for all Y = (u, w, p, p, q, q ) H,Ω H H,v H,v H,B H,B, were F n = (F n, F n, F 3, F, F, F 6 ) T, F n(x,y) = Mn t (Ω, u) + (v Ω, u) + µa(ω, u) (B C, u), F n(x,y) = Mn t (C, w) + ( (v C, ) w) (B Ω n, w) P(v,B, w), Ω F 3 (X,Y) = a(v, p ) + y, p, F (X,Y) = a(v, p ) ( Ω, p ), ( ) C F (X,Y) = a(b, q ) + y, q, F 6 (X,Y) = a(b, q ) ( C, q ), (u, w) = K uwdx, Mn t (u, w) = t (u un, w), a(u, w) = K u wdx, P((u, u ), (v, v ), w) = K [u, v ]wdx + K [u, v ]wdx. Let K be a given triangulation of domain K wit te maximum diameter of te element triangles. Let V be te continuous piecewise linear finite element space. Let V A, A = Ω, v, v, B, B, be te subsets of V wic satisfy te boundary conditions of A on every boundary point of K and V A be subspaces of V and H,A. Ten we can write te discretized MHD problems as follows: For eac n, find te solutions X n = (Ωn, Cn, vn,, vn,, Bn,, Bn, ) V Ω V V v V v V B V B for all Y V Ω V V v V v V B V B. on eac discretized times n wic satisfy F n (X n,y ) = () 3 Nonlinear and linear solvers () is a nonlinear problem in te six variables consisting of two time dependent equations and four Poisson equations. However, if we consider te equations separately, eac equation is linear wit respect to one variable. Specifically, te last four equations are linear equations and Poisson problems. From te above observations, we naturally consider a nonlinear Gauss-Seidel iterative solvers (GS) wic solve linear eac equation on one variable in () in consecutive order wit recent approximate solutions. Poisson solvers are well developed and te first two equations are time dependent problems. From tis observation, we consider anoter nonlinear Gauss-Seidel iterative solvers (GS) wic solve first two equations of () as one equation and solve four Poisson equations. Nonlinear Gauss-Seidel iterative metod doesn t guarantee convergence, but converges well in many cases, especially for small time step sizes in time dependent problems. Next, we consider te Newton linearization metod. Newton s metod as, asymptotically, second-order convergence for nonlinear problems and greater

4 Kab Seo Kang scalability wit respect to mes refinement tan te nonlinear Gauss-Seidel metod, but requires computation of te Jacobian of nonlinear problem wic can be complicated. In all tree nonlinear solvers, we need to solve linear problems. Krylov iterative tecniques are suited because tey can be preconditioned for efficiency. Among te various Krylov metods, GMRES (Generalized Minimal RESiduals) is selected because it guarantees convergence wit nonsymmetric, nonpositive definite systems. However, GMRES can be memory intensive (storage increases linearly wit te number of GMRES iterations per Jacobian solve) and expensive (computational complexity of GMRES increases wit te square of te number of GMRES iterations per Jacobian solve). Restarted GMRES can in principal deal wit tese limitations; owever, it lacs a teory of convergence, and stalling is frequently observed in real applications. Preconditioning consists in operating on te system matrix J were J δx = F(x ) (6) wit an operator P (preconditioner) suc tat J P (rigt preconditioning) or P J (left preconditioning) is well-conditioned. In tis study, we use left preconditioning because tis can be implemented easily. Tis is straigtforward to see wen considering te equivalent linear system: P J δx = P F(x ). (7) Notice tat te system in equation (7) is equivalent to te original system (6) for any nonsingular operator P. Tus, te coice of P does not affect te accuracy of te final solution, but crucially determines te rate of convergence of GMRES, and ence te efficiency of te algoritm. In tis study, we use multigrid wic is well nown as a successful preconditioner, as well as a scalable solver in unaccelerated form, for many problems. We consider te symmetrized diagonal term of Jacobian as a reduced system, i.e., J S, = ( JR, + J T ) R,, () were J R, is a bloc diagonal matrix. Te reduced system J S, may be less efficient tan J R, but more numerically stable because it is symmetric and nonsingular. To implement te finite element solver for two-dimensional, incompressible MHD on parallel macines, we use PETSc library wic is well developed for nonlinear PDE problems and easily implements a multigrid preconditioner wit GMRES. We use PETSc s index sets for parallelization of our unstructured finite element discretization.

5 New Streamfunction Approac for Magnetoydrodynamics Numerical experiments : Tilt Instability { [/J ()]J We consider te initial equilibrium state as ψ = (r) y r, r <, (/r r) y r, r >, were J n is te Bessel function of order n, is any constant tat satisfies J () =, and r = x + y (a) t = (b) t = (c) t = (d) t = 7.. Fig.. Contours of Ω, C, φ, and ψ at time t =.,., 6., 7.. In our numerical experiments, we solve on te finite square domain K = [ R, R] [ R, R] wit te initial condition of te tilt instability problem from te above initial equilibrium and perturbation of φ (originating from perturbations of velocity) suc tat { 9.773J (r)y/r if r < Ω() =., C() = {. if r >, φ() = 3 e (x +y ).9966J (r)y/r if r <, ψ() = r)y/r if r >, ( r

6 Kab Seo Kang were = and wit Diriclet boundary conditions Ω(x, y, t) =., φ(x, y, t) =., and ψ(x, y, t) = y y x +y and Neumann boundary condition for C, i.e., C n (x, y, t) =.. Te initial and boundary condition for velocity v and magnetic field B are derived from te initial and boundary condition of Ω, C, φ, and ψ. Numerical simulation results are illustrated in Fig.. Te tilt instability problem is defined on unbounded domain. To investigate te effect of size of domains, we simulate two metods, one uses φ, ψ and its derivatives (SL) and te oter uses v and B (K) on te square domains wit R = and R = 3. Tese numerical simulation results are reported in Fig., te contours of ψ at t = 6.. Te average growt rate γ of inetic energy is sown in Table. Tese numerical simulation results sow tat te solutions of two formulations are closer wen te domain is enlarged, wit te previous approac converging from above and new approac converging from below (a) R = 3 (SL). (b) R = 3(K). (c) R = (SL). (d) R = (K). Fig.. Contours of ψ at T = 7.. Table. Average growt rate γ of inetic energy from t =. to t = 6. previous, R = previous, R = 3 new, R = new, R = From ere, we consider te convergence beaviors of several nonlinear and linear solvers as a function of time step sizes. In Table, we report te number of nonlinear iterations of nonlinear solvers according to time step sizes for te fixed staring time and fixed mes level. We coose t =. and t = 6. as te starting time because many simulations ave trouble at start up time and te magnitudes of te velocity (v, v ) and magnetic field (B, B ) increase wit time. Tese numerical results sow tat GS and Newton metod are more nonlinearly robust tan GS. To investigate anoter convergence beavior, we report te average number of linear iterations in one time step according to preconditioners in Table 3. Numerical results sow tat multigrid preconditioner applying on symmetrized reduced system is robust at t =. and t = 6., but multigrid

7 New Streamfunction Approac for Magnetoydrodynamics 7 Table. Te average number of nonlinear iterations of one time step according to time step sizes dt. dt GS GS NM t = t = 6 t = t = 6 t = t = () * * 7. * * 6 3 applied to te reduced system is robust only at t =., very similar to te symmetrized case, because te values of velocity are small at t =.. Tese results sow tat we ave to use multigrid preconditioner applied to te symmetrized reduced system to get good convergence. Table 3. Te average number of linear iterations in one time step according to time step sizes dt GS(R) GS(S) NM(R) NM(S) t = t = 6 t = t = 6 t = t = 6 t = t = *. *.. *. 7.. * * In Table, we report te average number of nonlinear and linear iterations from t =. to t =. wit dt =. according to te levels. Tese results sow tat two numerical metod GS(S) and Newton metod (S) ave very similar beaviors. Table. Average number of iterations according to te number of level. Solvers GS(S) NM(S) level nonlinear linear nonlinear linear In Table, we report te solution times of one time step according to level and number of processors on te cluster macine BGC (te Brooaven

8 Kab Seo Kang Galaxy Cluster) at BNL. We run te program on te same speed (696 MHz) CPU s. Tis table sows tat Newton s metod ave a better scalabilty GS. Table. Average solving time of one time step (linear system) according to level and number of processors at t =. and dt =. level # CPU GS(S) NM(S) 3.7 (.39).3 (.) 3.3 (.7) 7.76 (.). (.3) 33. (6.6) 9. (7.79). (.3) 3.6 (.) 9.9 (.9) 6. (3.9) 9.9 (.) 6 6. (9.3) 39. (9.6) 3. (36.9) 6.6 (7.) (6.).9 (36.) Conclusions We study te new streamfunction approac metod for two-dimensional, incompressible Magnetoydrodynamics wit finite element metod and tilt instability example. We sow tat nonlinear Gauss-Seidel (GS) and Newton metod ave similar numerical beaviors and ave to employ multigrid preconditioner on te symmetrized reduced system for good linear convergence. Acnowledgement Te autor would lie to tan D. E. Keyes of Columbia University for is valuable advice in te preparation of tis wor. Tis wor was supported by te United States Department of Energy under contract No. DE-AC- 9CH6. References [SL9] Strauss, H. R. and Longcope, D. W.: An Adaptive Finite Element Metod for Magnetoydrodynamics., Journal of Computational Pysics, 7:3 336, 99.

Dedicated to the 70th birthday of Professor Lin Qun

Dedicated to the 70th birthday of Professor Lin Qun Journal of Computational Matematics, Vol.4, No.3, 6, 4 44. ACCELERATION METHODS OF NONLINEAR ITERATION FOR NONLINEAR PARABOLIC EQUATIONS Guang-wei Yuan Xu-deng Hang Laboratory of Computational Pysics,

More information

Chapter 5 FINITE DIFFERENCE METHOD (FDM)

Chapter 5 FINITE DIFFERENCE METHOD (FDM) MEE7 Computer Modeling Tecniques in Engineering Capter 5 FINITE DIFFERENCE METHOD (FDM) 5. Introduction to FDM Te finite difference tecniques are based upon approximations wic permit replacing differential

More information

AN EFFICIENT AND ROBUST METHOD FOR SIMULATING TWO-PHASE GEL DYNAMICS

AN EFFICIENT AND ROBUST METHOD FOR SIMULATING TWO-PHASE GEL DYNAMICS AN EFFICIENT AND ROBUST METHOD FOR SIMULATING TWO-PHASE GEL DYNAMICS GRADY B. WRIGHT, ROBERT D. GUY, AND AARON L. FOGELSON Abstract. We develop a computational metod for simulating models of gel dynamics

More information

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps A metod of Lagrange Galerkin of second order in time Une métode de Lagrange Galerkin d ordre deux en temps Jocelyn Étienne a a DAMTP, University of Cambridge, Wilberforce Road, Cambridge CB3 0WA, Great-Britain.

More information

Finite Difference Methods Assignments

Finite Difference Methods Assignments Finite Difference Metods Assignments Anders Söberg and Aay Saxena, Micael Tuné, and Maria Westermarck Revised: Jarmo Rantakokko June 6, 1999 Teknisk databeandling Assignment 1: A one-dimensional eat equation

More information

Preconditioning in H(div) and Applications

Preconditioning in H(div) and Applications 1 Preconditioning in H(div) and Applications Douglas N. Arnold 1, Ricard S. Falk 2 and Ragnar Winter 3 4 Abstract. Summarizing te work of [AFW97], we sow ow to construct preconditioners using domain decomposition

More information

FEM solution of the ψ-ω equations with explicit viscous diffusion 1

FEM solution of the ψ-ω equations with explicit viscous diffusion 1 FEM solution of te ψ-ω equations wit explicit viscous diffusion J.-L. Guermond and L. Quartapelle 3 Abstract. Tis paper describes a variational formulation for solving te D time-dependent incompressible

More information

Parameter Fitted Scheme for Singularly Perturbed Delay Differential Equations

Parameter Fitted Scheme for Singularly Perturbed Delay Differential Equations International Journal of Applied Science and Engineering 2013. 11, 4: 361-373 Parameter Fitted Sceme for Singularly Perturbed Delay Differential Equations Awoke Andargiea* and Y. N. Reddyb a b Department

More information

Order of Accuracy. ũ h u Ch p, (1)

Order of Accuracy. ũ h u Ch p, (1) Order of Accuracy 1 Terminology We consider a numerical approximation of an exact value u. Te approximation depends on a small parameter, wic can be for instance te grid size or time step in a numerical

More information

Arbitrary order exactly divergence-free central discontinuous Galerkin methods for ideal MHD equations

Arbitrary order exactly divergence-free central discontinuous Galerkin methods for ideal MHD equations Arbitrary order exactly divergence-free central discontinuous Galerkin metods for ideal MHD equations Fengyan Li, Liwei Xu Department of Matematical Sciences, Rensselaer Polytecnic Institute, Troy, NY

More information

The Laplace equation, cylindrically or spherically symmetric case

The Laplace equation, cylindrically or spherically symmetric case Numerisce Metoden II, 7 4, und Übungen, 7 5 Course Notes, Summer Term 7 Some material and exercises Te Laplace equation, cylindrically or sperically symmetric case Electric and gravitational potential,

More information

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx.

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx. Capter 2 Integrals as sums and derivatives as differences We now switc to te simplest metods for integrating or differentiating a function from its function samples. A careful study of Taylor expansions

More information

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS SIAM J. NUMER. ANAL. c 998 Society for Industrial Applied Matematics Vol. 35, No., pp. 393 405, February 998 00 LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS YANZHAO CAO

More information

Finite Difference Method

Finite Difference Method Capter 8 Finite Difference Metod 81 2nd order linear pde in two variables General 2nd order linear pde in two variables is given in te following form: L[u] = Au xx +2Bu xy +Cu yy +Du x +Eu y +Fu = G According

More information

How to Find the Derivative of a Function: Calculus 1

How to Find the Derivative of a Function: Calculus 1 Introduction How to Find te Derivative of a Function: Calculus 1 Calculus is not an easy matematics course Te fact tat you ave enrolled in suc a difficult subject indicates tat you are interested in te

More information

Exercise 19 - OLD EXAM, FDTD

Exercise 19 - OLD EXAM, FDTD Exercise 19 - OLD EXAM, FDTD A 1D wave propagation may be considered by te coupled differential equations u x + a v t v x + b u t a) 2 points: Derive te decoupled differential equation and give c in terms

More information

arxiv: v1 [math.na] 3 Nov 2011

arxiv: v1 [math.na] 3 Nov 2011 arxiv:.983v [mat.na] 3 Nov 2 A Finite Difference Gost-cell Multigrid approac for Poisson Equation wit mixed Boundary Conditions in Arbitrary Domain Armando Coco, Giovanni Russo November 7, 2 Abstract In

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximatinga function fx, wose values at a set of distinct points x, x, x,, x n are known, by a polynomial P x suc

More information

Multigrid Methods for Obstacle Problems

Multigrid Methods for Obstacle Problems Multigrid Metods for Obstacle Problems by Cunxiao Wu A Researc Paper presented to te University of Waterloo in partial fulfillment of te requirement for te degree of Master of Matematics in Computational

More information

Jian-Guo Liu 1 and Chi-Wang Shu 2

Jian-Guo Liu 1 and Chi-Wang Shu 2 Journal of Computational Pysics 60, 577 596 (000) doi:0.006/jcp.000.6475, available online at ttp://www.idealibrary.com on Jian-Guo Liu and Ci-Wang Su Institute for Pysical Science and Tecnology and Department

More information

AMS 147 Computational Methods and Applications Lecture 09 Copyright by Hongyun Wang, UCSC. Exact value. Effect of round-off error.

AMS 147 Computational Methods and Applications Lecture 09 Copyright by Hongyun Wang, UCSC. Exact value. Effect of round-off error. Lecture 09 Copyrigt by Hongyun Wang, UCSC Recap: Te total error in numerical differentiation fl( f ( x + fl( f ( x E T ( = f ( x Numerical result from a computer Exact value = e + f x+ Discretization error

More information

Discontinuous Galerkin Methods for Relativistic Vlasov-Maxwell System

Discontinuous Galerkin Methods for Relativistic Vlasov-Maxwell System Discontinuous Galerkin Metods for Relativistic Vlasov-Maxwell System He Yang and Fengyan Li December 1, 16 Abstract e relativistic Vlasov-Maxwell (RVM) system is a kinetic model tat describes te dynamics

More information

A = h w (1) Error Analysis Physics 141

A = h w (1) Error Analysis Physics 141 Introduction In all brances of pysical science and engineering one deals constantly wit numbers wic results more or less directly from experimental observations. Experimental observations always ave inaccuracies.

More information

Quantum Numbers and Rules

Quantum Numbers and Rules OpenStax-CNX module: m42614 1 Quantum Numbers and Rules OpenStax College Tis work is produced by OpenStax-CNX and licensed under te Creative Commons Attribution License 3.0 Abstract Dene quantum number.

More information

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems 5 Ordinary Differential Equations: Finite Difference Metods for Boundary Problems Read sections 10.1, 10.2, 10.4 Review questions 10.1 10.4, 10.8 10.9, 10.13 5.1 Introduction In te previous capters we

More information

MANY scientific and engineering problems can be

MANY scientific and engineering problems can be A Domain Decomposition Metod using Elliptical Arc Artificial Boundary for Exterior Problems Yajun Cen, and Qikui Du Abstract In tis paper, a Diriclet-Neumann alternating metod using elliptical arc artificial

More information

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER*

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER* EO BOUNDS FO THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BADLEY J. LUCIE* Abstract. Te expected error in L ) attimet for Glimm s sceme wen applied to a scalar conservation law is bounded by + 2 ) ) /2 T

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximating a function f(x, wose values at a set of distinct points x, x, x 2,,x n are known, by a polynomial P (x

More information

Robotic manipulation project

Robotic manipulation project Robotic manipulation project Bin Nguyen December 5, 2006 Abstract Tis is te draft report for Robotic Manipulation s class project. Te cosen project aims to understand and implement Kevin Egan s non-convex

More information

Click here to see an animation of the derivative

Click here to see an animation of the derivative Differentiation Massoud Malek Derivative Te concept of derivative is at te core of Calculus; It is a very powerful tool for understanding te beavior of matematical functions. It allows us to optimize functions,

More information

The Verlet Algorithm for Molecular Dynamics Simulations

The Verlet Algorithm for Molecular Dynamics Simulations Cemistry 380.37 Fall 2015 Dr. Jean M. Standard November 9, 2015 Te Verlet Algoritm for Molecular Dynamics Simulations Equations of motion For a many-body system consisting of N particles, Newton's classical

More information

ch (for some fixed positive number c) reaching c

ch (for some fixed positive number c) reaching c GSTF Journal of Matematics Statistics and Operations Researc (JMSOR) Vol. No. September 05 DOI 0.60/s4086-05-000-z Nonlinear Piecewise-defined Difference Equations wit Reciprocal and Cubic Terms Ramadan

More information

arxiv: v1 [physics.flu-dyn] 3 Jun 2015

arxiv: v1 [physics.flu-dyn] 3 Jun 2015 A Convective-like Energy-Stable Open Boundary Condition for Simulations of Incompressible Flows arxiv:156.132v1 [pysics.flu-dyn] 3 Jun 215 S. Dong Center for Computational & Applied Matematics Department

More information

Domain-decomposed Fully Coupled Implicit Methods for a Magnetohydrodynamics Problem

Domain-decomposed Fully Coupled Implicit Methods for a Magnetohydrodynamics Problem Domain-decomposed Fully Coupled Implicit Methods for a Magnetohydrodynamics Problem Serguei Ovtchinniov 1, Florin Dobrian 2, Xiao-Chuan Cai 3, David Keyes 4 1 University of Colorado at Boulder, Department

More information

A Numerical Scheme for Particle-Laden Thin Film Flow in Two Dimensions

A Numerical Scheme for Particle-Laden Thin Film Flow in Two Dimensions A Numerical Sceme for Particle-Laden Tin Film Flow in Two Dimensions Mattew R. Mata a,, Andrea L. Bertozzi a a Department of Matematics, University of California Los Angeles, 520 Portola Plaza, Los Angeles,

More information

Physically Based Modeling: Principles and Practice Implicit Methods for Differential Equations

Physically Based Modeling: Principles and Practice Implicit Methods for Differential Equations Pysically Based Modeling: Principles and Practice Implicit Metods for Differential Equations David Baraff Robotics Institute Carnegie Mellon University Please note: Tis document is 997 by David Baraff

More information

arxiv: v1 [math.na] 9 Sep 2015

arxiv: v1 [math.na] 9 Sep 2015 arxiv:509.02595v [mat.na] 9 Sep 205 An Expandable Local and Parallel Two-Grid Finite Element Sceme Yanren ou, GuangZi Du Abstract An expandable local and parallel two-grid finite element sceme based on

More information

Application of numerical integration methods to continuously variable transmission dynamics models a

Application of numerical integration methods to continuously variable transmission dynamics models a ttps://doi.org/10.1051/ssconf/2018440005 Application of numerical integration metods to continuously variable transmission dynamics models a Orlov Stepan 1 1 Peter te Great St. Petersburg Polytecnic University

More information

A Modified Distributed Lagrange Multiplier/Fictitious Domain Method for Particulate Flows with Collisions

A Modified Distributed Lagrange Multiplier/Fictitious Domain Method for Particulate Flows with Collisions A Modified Distributed Lagrange Multiplier/Fictitious Domain Metod for Particulate Flows wit Collisions P. Sing Department of Mecanical Engineering New Jersey Institute of Tecnology University Heigts Newark,

More information

Implicit-explicit variational integration of highly oscillatory problems

Implicit-explicit variational integration of highly oscillatory problems Implicit-explicit variational integration of igly oscillatory problems Ari Stern Structured Integrators Worksop April 9, 9 Stern, A., and E. Grinspun. Multiscale Model. Simul., to appear. arxiv:88.39 [mat.na].

More information

Downloaded 01/08/14 to Redistribution subject to SIAM license or copyright; see

Downloaded 01/08/14 to Redistribution subject to SIAM license or copyright; see SIAM J. SCI. COMPUT. Vol. 3, No. 3, pp. 506 56 c 00 Society for Industrial and Applied Matematics NESTED ITERATION AND FIRST-ORDER SYSTEM LEAST SQUARES FOR INCOMPRESSIBLE, RESISTIVE MAGNETOHYDRODYNAMICS

More information

LIMITATIONS OF EULER S METHOD FOR NUMERICAL INTEGRATION

LIMITATIONS OF EULER S METHOD FOR NUMERICAL INTEGRATION LIMITATIONS OF EULER S METHOD FOR NUMERICAL INTEGRATION LAURA EVANS.. Introduction Not all differential equations can be explicitly solved for y. Tis can be problematic if we need to know te value of y

More information

arxiv: v3 [math.na] 15 Dec 2009

arxiv: v3 [math.na] 15 Dec 2009 THE NAVIER-STOKES-VOIGHT MODEL FOR IMAGE INPAINTING M.A. EBRAHIMI, MICHAEL HOLST, AND EVELYN LUNASIN arxiv:91.4548v3 [mat.na] 15 Dec 9 ABSTRACT. In tis paper we investigate te use of te D Navier-Stokes-Voigt

More information

Continuity and Differentiability of the Trigonometric Functions

Continuity and Differentiability of the Trigonometric Functions [Te basis for te following work will be te definition of te trigonometric functions as ratios of te sides of a triangle inscribed in a circle; in particular, te sine of an angle will be defined to be te

More information

MATH745 Fall MATH745 Fall

MATH745 Fall MATH745 Fall MATH745 Fall 5 MATH745 Fall 5 INTRODUCTION WELCOME TO MATH 745 TOPICS IN NUMERICAL ANALYSIS Instructor: Dr Bartosz Protas Department of Matematics & Statistics Email: bprotas@mcmasterca Office HH 36, Ext

More information

4. The slope of the line 2x 7y = 8 is (a) 2/7 (b) 7/2 (c) 2 (d) 2/7 (e) None of these.

4. The slope of the line 2x 7y = 8 is (a) 2/7 (b) 7/2 (c) 2 (d) 2/7 (e) None of these. Mat 11. Test Form N Fall 016 Name. Instructions. Te first eleven problems are wort points eac. Te last six problems are wort 5 points eac. For te last six problems, you must use relevant metods of algebra

More information

A First-Order System Approach for Diffusion Equation. I. Second-Order Residual-Distribution Schemes

A First-Order System Approach for Diffusion Equation. I. Second-Order Residual-Distribution Schemes A First-Order System Approac for Diffusion Equation. I. Second-Order Residual-Distribution Scemes Hiroaki Nisikawa W. M. Keck Foundation Laboratory for Computational Fluid Dynamics, Department of Aerospace

More information

COMPUTATIONAL COMPARISON BETWEEN THE TAYLOR HOOD AND THE CONFORMING CROUZEIX RAVIART ELEMENT

COMPUTATIONAL COMPARISON BETWEEN THE TAYLOR HOOD AND THE CONFORMING CROUZEIX RAVIART ELEMENT Proceedings of ALGORITMY 5 pp. 369 379 COMPUTATIONAL COMPARISON BETWEEN E TAYLOR HOOD AND E CONFORMING OUZEIX RAVIART ELEMENT ROLF KRAHL AND EBERHARD BÄNSCH Abstract. Tis paper is concerned wit te computational

More information

Quantum Theory of the Atomic Nucleus

Quantum Theory of the Atomic Nucleus G. Gamow, ZP, 51, 204 1928 Quantum Teory of te tomic Nucleus G. Gamow (Received 1928) It as often been suggested tat non Coulomb attractive forces play a very important role inside atomic nuclei. We can

More information

Entropy and the numerical integration of conservation laws

Entropy and the numerical integration of conservation laws Pysics Procedia Pysics Procedia 00 2011) 1 28 Entropy and te numerical integration of conservation laws Gabriella Puppo Dipartimento di Matematica, Politecnico di Torino Italy) Matteo Semplice Dipartimento

More information

Research Article Cubic Spline Iterative Method for Poisson s Equation in Cylindrical Polar Coordinates

Research Article Cubic Spline Iterative Method for Poisson s Equation in Cylindrical Polar Coordinates International Scolarly Researc Network ISRN Matematical Pysics Volume 202, Article ID 2456, pages doi:0.5402/202/2456 Researc Article Cubic Spline Iterative Metod for Poisson s Equation in Cylindrical

More information

Differential equations. Differential equations

Differential equations. Differential equations Differential equations A differential equation (DE) describes ow a quantity canges (as a function of time, position, ) d - A ball dropped from a building: t gt () dt d S qx - Uniformly loaded beam: wx

More information

27. A Non-Overlapping Optimized Schwarz Method which Converges with Arbitrarily Weak Dependence on h

27. A Non-Overlapping Optimized Schwarz Method which Converges with Arbitrarily Weak Dependence on h Fourteent International Conference on Domain Decomposition Metods Editors: Ismael Herrera, David E. Keyes, Olof B. Widlund, Robert Yates c 003 DDM.org 7. A Non-Overlapping Optimized Scwarz Metod wic Converges

More information

, meant to remind us of the definition of f (x) as the limit of difference quotients: = lim

, meant to remind us of the definition of f (x) as the limit of difference quotients: = lim Mat 132 Differentiation Formulas Stewart 2.3 So far, we ave seen ow various real-world problems rate of cange and geometric problems tangent lines lead to derivatives. In tis section, we will see ow to

More information

NUMERICAL DIFFERENTIATION. James T. Smith San Francisco State University. In calculus classes, you compute derivatives algebraically: for example,

NUMERICAL DIFFERENTIATION. James T. Smith San Francisco State University. In calculus classes, you compute derivatives algebraically: for example, NUMERICAL DIFFERENTIATION James T Smit San Francisco State University In calculus classes, you compute derivatives algebraically: for example, f( x) = x + x f ( x) = x x Tis tecnique requires your knowing

More information

c 2006 Society for Industrial and Applied Mathematics

c 2006 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 27, No. 4, pp. 47 492 c 26 Society for Industrial and Applied Matematics A NOVEL MULTIGRID BASED PRECONDITIONER FOR HETEROGENEOUS HELMHOLTZ PROBLEMS Y. A. ERLANGGA, C. W. OOSTERLEE,

More information

MA455 Manifolds Solutions 1 May 2008

MA455 Manifolds Solutions 1 May 2008 MA455 Manifolds Solutions 1 May 2008 1. (i) Given real numbers a < b, find a diffeomorpism (a, b) R. Solution: For example first map (a, b) to (0, π/2) and ten map (0, π/2) diffeomorpically to R using

More information

Combining functions: algebraic methods

Combining functions: algebraic methods Combining functions: algebraic metods Functions can be added, subtracted, multiplied, divided, and raised to a power, just like numbers or algebra expressions. If f(x) = x 2 and g(x) = x + 2, clearly f(x)

More information

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems Applied Matematics, 06, 7, 74-8 ttp://wwwscirporg/journal/am ISSN Online: 5-7393 ISSN Print: 5-7385 Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for

More information

Mixed Finite Element Methods for Incompressible Flow: Stationary Stokes Equations

Mixed Finite Element Methods for Incompressible Flow: Stationary Stokes Equations Mixed Finite Element Metods for Incompressible Flow: Stationary Stoes Equations Ziqiang Cai, Carles Tong, 2 Panayot S. Vassilevsi, 2 Cunbo Wang Department of Matematics, Purdue University, West Lafayette,

More information

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Hybrid Mixed Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

1.72, Groundwater Hydrology Prof. Charles Harvey Lecture Packet #9: Numerical Modeling of Groundwater Flow

1.72, Groundwater Hydrology Prof. Charles Harvey Lecture Packet #9: Numerical Modeling of Groundwater Flow 1.7, Groundwater Hydrology Prof. Carles Harvey Lecture Packet #9: Numerical Modeling of Groundwater Flow Simulation: Te prediction of quantities of interest (dependent variables) based upon an equation

More information

Advancements In Finite Element Methods For Newtonian And Non-Newtonian Flows

Advancements In Finite Element Methods For Newtonian And Non-Newtonian Flows Clemson University TigerPrints All Dissertations Dissertations 8-3 Advancements In Finite Element Metods For Newtonian And Non-Newtonian Flows Keit Galvin Clemson University, kjgalvi@clemson.edu Follow

More information

Module 4 Linear Boundary value problems

Module 4 Linear Boundary value problems Module 4 Linear Boundary value problems Lecture Content Hours 1 Finite Difference Metods: Diriclet type boundary 1 condition Finite Difference Metods: Mixed boundary condition 1 3 Sooting Metod 1 4 Sooting

More information

2.11 That s So Derivative

2.11 That s So Derivative 2.11 Tat s So Derivative Introduction to Differential Calculus Just as one defines instantaneous velocity in terms of average velocity, we now define te instantaneous rate of cange of a function at a point

More information

Improved Rotated Finite Difference Method for Solving Fractional Elliptic Partial Differential Equations

Improved Rotated Finite Difference Method for Solving Fractional Elliptic Partial Differential Equations American Scientific Researc Journal for Engineering, Tecnolog, and Sciences (ASRJETS) ISSN (Print) 33-44, ISSN (Online) 33-44 Global Societ of Scientific Researc and Researcers ttp://asrjetsjournal.org/

More information

Crouzeix-Velte Decompositions and the Stokes Problem

Crouzeix-Velte Decompositions and the Stokes Problem Crouzeix-Velte Decompositions and te Stokes Problem PD Tesis Strauber Györgyi Eötvös Loránd University of Sciences, Insitute of Matematics, Matematical Doctoral Scool Director of te Doctoral Scool: Dr.

More information

Differentiation in higher dimensions

Differentiation in higher dimensions Capter 2 Differentiation in iger dimensions 2.1 Te Total Derivative Recall tat if f : R R is a 1-variable function, and a R, we say tat f is differentiable at x = a if and only if te ratio f(a+) f(a) tends

More information

Computers and Mathematics with Applications. A nonlinear weighted least-squares finite element method for Stokes equations

Computers and Mathematics with Applications. A nonlinear weighted least-squares finite element method for Stokes equations Computers Matematics wit Applications 59 () 5 4 Contents lists available at ScienceDirect Computers Matematics wit Applications journal omepage: www.elsevier.com/locate/camwa A nonlinear weigted least-squares

More information

1 Limits and Continuity

1 Limits and Continuity 1 Limits and Continuity 1.0 Tangent Lines, Velocities, Growt In tion 0.2, we estimated te slope of a line tangent to te grap of a function at a point. At te end of tion 0.3, we constructed a new function

More information

Numerical Differentiation

Numerical Differentiation Numerical Differentiation Finite Difference Formulas for te first derivative (Using Taylor Expansion tecnique) (section 8.3.) Suppose tat f() = g() is a function of te variable, and tat as 0 te function

More information

Numerical Solution to Parabolic PDE Using Implicit Finite Difference Approach

Numerical Solution to Parabolic PDE Using Implicit Finite Difference Approach Numerical Solution to arabolic DE Using Implicit Finite Difference Approac Jon Amoa-Mensa, Francis Oene Boateng, Kwame Bonsu Department of Matematics and Statistics, Sunyani Tecnical University, Sunyani,

More information

An Efficient Multigrid Solver for a Reformulated Version of the Poroelasticity System

An Efficient Multigrid Solver for a Reformulated Version of the Poroelasticity System An Efficient Multigrid Solver for a Reformulated Version of te Poroelasticity System F.J. Gaspar a F.J. Lisbona a, C.W. Oosterlee b P.N. Vabiscevic c a Departamento de Matemática Aplicada, University of

More information

Solving Continuous Linear Least-Squares Problems by Iterated Projection

Solving Continuous Linear Least-Squares Problems by Iterated Projection Solving Continuous Linear Least-Squares Problems by Iterated Projection by Ral Juengling Department o Computer Science, Portland State University PO Box 75 Portland, OR 977 USA Email: juenglin@cs.pdx.edu

More information

5.74 Introductory Quantum Mechanics II

5.74 Introductory Quantum Mechanics II MIT OpenCourseWare ttp://ocw.mit.edu 5.74 Introductory Quantum Mecanics II Spring 9 For information about citing tese materials or our Terms of Use, visit: ttp://ocw.mit.edu/terms. Andrei Tokmakoff, MIT

More information

HARMONIC ALLOCATION TO MV CUSTOMERS IN RURAL DISTRIBUTION SYSTEMS

HARMONIC ALLOCATION TO MV CUSTOMERS IN RURAL DISTRIBUTION SYSTEMS HARMONIC ALLOCATION TO MV CUSTOMERS IN RURAL DISTRIBUTION SYSTEMS V Gosbell University of Wollongong Department of Electrical, Computer & Telecommunications Engineering, Wollongong, NSW 2522, Australia

More information

Section 3: The Derivative Definition of the Derivative

Section 3: The Derivative Definition of the Derivative Capter 2 Te Derivative Business Calculus 85 Section 3: Te Derivative Definition of te Derivative Returning to te tangent slope problem from te first section, let's look at te problem of finding te slope

More information

Copyright c 2008 Kevin Long

Copyright c 2008 Kevin Long Lecture 4 Numerical solution of initial value problems Te metods you ve learned so far ave obtained closed-form solutions to initial value problems. A closedform solution is an explicit algebriac formula

More information

1. Questions (a) through (e) refer to the graph of the function f given below. (A) 0 (B) 1 (C) 2 (D) 4 (E) does not exist

1. Questions (a) through (e) refer to the graph of the function f given below. (A) 0 (B) 1 (C) 2 (D) 4 (E) does not exist Mat 1120 Calculus Test 2. October 18, 2001 Your name Te multiple coice problems count 4 points eac. In te multiple coice section, circle te correct coice (or coices). You must sow your work on te oter

More information

NESTED ITERATION AND FIRST-ORDER SYSTEM LEAST SQUARES FOR INCOMPRESSIBLE, RESISTIVE MAGNETOHYDRODYNAMICS

NESTED ITERATION AND FIRST-ORDER SYSTEM LEAST SQUARES FOR INCOMPRESSIBLE, RESISTIVE MAGNETOHYDRODYNAMICS NESTED ITERATION AND FIRST-ORDER SYSTEM LEAST SQUARES FOR INCOMPRESSIBLE, RESISTIVE MAGNETOHYDRODYNAMICS J. H. ADLER, T. A. MANTEUFFEL, S. F. MCCORMICK, J. W. RUGE, AND G. D. SANDERS Abstract. Tis paper

More information

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801 RESEARCH SUMMARY AND PERSPECTIVES KOFFI B. FADIMBA Department of Matematical Sciences University of Sout Carolina Aiken Aiken, SC 29801 Email: KoffiF@usca.edu 1. Introduction My researc program as focused

More information

Simulations of the turbulent channel flow at Re τ = 180 with projection-based finite element variational multiscale methods

Simulations of the turbulent channel flow at Re τ = 180 with projection-based finite element variational multiscale methods INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Met. Fluids 7; 55:47 49 Publised online 4 Marc 7 in Wiley InterScience (www.interscience.wiley.com). DOI:./fld.46 Simulations of te

More information

CONVERGENCE ANALYSIS OF YEE SCHEMES FOR MAXWELL S EQUATIONS IN DEBYE AND LORENTZ DISPERSIVE MEDIA

CONVERGENCE ANALYSIS OF YEE SCHEMES FOR MAXWELL S EQUATIONS IN DEBYE AND LORENTZ DISPERSIVE MEDIA INTRNATIONAL JOURNAL OF NUMRICAL ANALYSIS AND MODLING Volume Number 4 ages 657 687 c 04 Institute for Scientific Computing and Information CONVRGNC ANALYSIS OF Y SCHMS FOR MAXWLL S QUATIONS IN DBY AND

More information

LIMITS AND DERIVATIVES CONDITIONS FOR THE EXISTENCE OF A LIMIT

LIMITS AND DERIVATIVES CONDITIONS FOR THE EXISTENCE OF A LIMIT LIMITS AND DERIVATIVES Te limit of a function is defined as te value of y tat te curve approaces, as x approaces a particular value. Te limit of f (x) as x approaces a is written as f (x) approaces, as

More information

DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Mathematics and Computer Science

DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Mathematics and Computer Science DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Matematics and Computer Science. ANSWERS OF THE TEST NUMERICAL METHODS FOR DIFFERENTIAL EQUATIONS (WI3097 TU) Tuesday January 9 008, 9:00-:00

More information

1. Which one of the following expressions is not equal to all the others? 1 C. 1 D. 25x. 2. Simplify this expression as much as possible.

1. Which one of the following expressions is not equal to all the others? 1 C. 1 D. 25x. 2. Simplify this expression as much as possible. 004 Algebra Pretest answers and scoring Part A. Multiple coice questions. Directions: Circle te letter ( A, B, C, D, or E ) net to te correct answer. points eac, no partial credit. Wic one of te following

More information

A SADDLE POINT LEAST SQUARES APPROACH TO MIXED METHODS

A SADDLE POINT LEAST SQUARES APPROACH TO MIXED METHODS A SADDLE POINT LEAST SQUARES APPROACH TO MIXED METHODS CONSTANTIN BACUTA AND KLAJDI QIRKO Abstract. We investigate new PDE discretization approaces for solving variational formulations wit different types

More information

Poisson Equation in Sobolev Spaces

Poisson Equation in Sobolev Spaces Poisson Equation in Sobolev Spaces OcMountain Dayligt Time. 6, 011 Today we discuss te Poisson equation in Sobolev spaces. It s existence, uniqueness, and regularity. Weak Solution. u = f in, u = g on

More information

232 Calculus and Structures

232 Calculus and Structures 3 Calculus and Structures CHAPTER 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS FOR EVALUATING BEAMS Calculus and Structures 33 Copyrigt Capter 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS 17.1 THE

More information

Recent Progress in the Integration of Poisson Systems via the Mid Point Rule and Runge Kutta Algorithm

Recent Progress in the Integration of Poisson Systems via the Mid Point Rule and Runge Kutta Algorithm Recent Progress in te Integration of Poisson Systems via te Mid Point Rule and Runge Kutta Algoritm Klaus Bucner, Mircea Craioveanu and Mircea Puta Abstract Some recent progress in te integration of Poisson

More information

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines Lecture 5 Interpolation II Introduction In te previous lecture we focused primarily on polynomial interpolation of a set of n points. A difficulty we observed is tat wen n is large, our polynomial as to

More information

INTRODUCTION AND MATHEMATICAL CONCEPTS

INTRODUCTION AND MATHEMATICAL CONCEPTS Capter 1 INTRODUCTION ND MTHEMTICL CONCEPTS PREVIEW Tis capter introduces you to te basic matematical tools for doing pysics. You will study units and converting between units, te trigonometric relationsips

More information

INTRODUCTION AND MATHEMATICAL CONCEPTS

INTRODUCTION AND MATHEMATICAL CONCEPTS INTODUCTION ND MTHEMTICL CONCEPTS PEVIEW Tis capter introduces you to te basic matematical tools for doing pysics. You will study units and converting between units, te trigonometric relationsips of sine,

More information

CONVERGENCE ANALYSIS OF YEE SCHEMES FOR MAXWELL S EQUATIONS IN DEBYE AND LORENTZ DISPERSIVE MEDIA

CONVERGENCE ANALYSIS OF YEE SCHEMES FOR MAXWELL S EQUATIONS IN DEBYE AND LORENTZ DISPERSIVE MEDIA INTRNATIONAL JOURNAL OF NUMRICAL ANALYSIS AND MODLING Volume XX Number 0 ages 45 c 03 Institute for Scientific Computing and Information CONVRGNC ANALYSIS OF Y SCHMS FOR MAXWLL S QUATIONS IN DBY AND LORNTZ

More information

A Distributed Lagrange Multiplier Based Fictitious Domain Method for Maxwell s Equations

A Distributed Lagrange Multiplier Based Fictitious Domain Method for Maxwell s Equations A Distributed Lagrange Multiplier Based Fictitious Domain Metod for Maxwell s Equations V. A. Bokil a and R. Glowinski b Center for Researc in Scientific Computation a Nort Carolina State University Box

More information

Investigating Euler s Method and Differential Equations to Approximate π. Lindsay Crowl August 2, 2001

Investigating Euler s Method and Differential Equations to Approximate π. Lindsay Crowl August 2, 2001 Investigating Euler s Metod and Differential Equations to Approximate π Lindsa Crowl August 2, 2001 Tis researc paper focuses on finding a more efficient and accurate wa to approximate π. Suppose tat x

More information

HOMEWORK HELP 2 FOR MATH 151

HOMEWORK HELP 2 FOR MATH 151 HOMEWORK HELP 2 FOR MATH 151 Here we go; te second round of omework elp. If tere are oters you would like to see, let me know! 2.4, 43 and 44 At wat points are te functions f(x) and g(x) = xf(x)continuous,

More information

Flavius Guiaş. X(t + h) = X(t) + F (X(s)) ds.

Flavius Guiaş. X(t + h) = X(t) + F (X(s)) ds. Numerical solvers for large systems of ordinary differential equations based on te stocastic direct simulation metod improved by te and Runge Kutta principles Flavius Guiaş Abstract We present a numerical

More information

GRID CONVERGENCE ERROR ANALYSIS FOR MIXED-ORDER NUMERICAL SCHEMES

GRID CONVERGENCE ERROR ANALYSIS FOR MIXED-ORDER NUMERICAL SCHEMES GRID CONVERGENCE ERROR ANALYSIS FOR MIXED-ORDER NUMERICAL SCHEMES Cristoper J. Roy Sandia National Laboratories* P. O. Box 5800, MS 085 Albuquerque, NM 8785-085 AIAA Paper 00-606 Abstract New developments

More information

AN ANALYSIS OF NEW FINITE ELEMENT SPACES FOR MAXWELL S EQUATIONS

AN ANALYSIS OF NEW FINITE ELEMENT SPACES FOR MAXWELL S EQUATIONS Journal of Matematical Sciences: Advances and Applications Volume 5 8 Pages -9 Available at ttp://scientificadvances.co.in DOI: ttp://d.doi.org/.864/jmsaa_7975 AN ANALYSIS OF NEW FINITE ELEMENT SPACES

More information