Level-Set Minimization of Potential Controlled Hadwiger Valuations for Molecular Solvation

Size: px
Start display at page:

Download "Level-Set Minimization of Potential Controlled Hadwiger Valuations for Molecular Solvation"

Transcription

1 Level-Set Minimization of Potential Controlled Hadwiger Valuations for Molecular Solvation Bo Li Dept. of Math & NSF Center for Theoretical Biological Physics UC San Diego, USA Collaborators: Li-Tien Cheng and Zhongming Wang $ $ $ NSF, DOE, and NIH $ $ $ Workshop on Numerical Methods for PDEs Sun Yat-Sen University, China, 7/28 8/1, 2010

2 Outline 1. Free-Energy Functional and Level-Set Equation 2. Discretization and Algorithm 3. A Technique of Numerical Integration 4. Convergence Test 5. Application to Molecular Solvation 6. Conclusions

3 1. Free-Energy Functional and Level-Set Equation

4

5 A variational implicit-solvent model (Dzubiella Swanson McCammon 1996).. n... Ω.. Ω in ex xn. Γ x 1. x i U LJ r G[Γ] = P 0 Vol (Ω in ) + γ 0 Area (Γ) 2γ 0 τ U(x) = N i=1 U (i) LJ ( x x i ) = i=1 Γ N [ (σi 4ǫ i r H ds + ρ 0 Ω ex UdV ) 12 ( σi ) ] 6. r

6 Hadwiger s Theorem Let C = { all convex compact subsets of R 3 }, M = { finite unions of members of C }, F : M R : translationally and rotationally invariant. Assume F(U V) = F(U) + F(V) F(U V) U, V M, F(U k ) F(U) if U, U k C (k 1) and U k U. Then there exist a 1,...,a 4 R such that for all U M F(U) = a 1 Vol (U) + a 2 Area ( U) + a 3 H ds + a 4 U U K ds.

7

8 Level-set representation of a moving surface Γ(t) = {x : φ(x, t) = 0}. Level-set equation t φ + v n φ = 0. Unit normal and normal velocity n = φ φ and v n = dx dt n. Mean curvature and Gaussian curvature H = 1 2 (κ 1 + κ 2 ) = 1 2 n and K = κ 1κ 2 = n adj ( 2 φ ) n.

9 Level-set optimization method t φ + v n φ = 0, v n = δ Γ G[Γ] = P 0 2γ 0 (H τk) + ρ 0 U. Recall G[Γ] = P 0 Vol (Ω in ) + γ 0 Area (Γ) 2γ 0 τ A steepest descent method [ d dx(t) dt G[Γ(t)] = δ Γ G[Γ(t)] dt Γ(t) Γ H ds + ρ 0 Ω ex UdV. ] n ds = [v n (x)] 2 ds 0. Γ(t)

10 2. Discretization and Algorithm

11 Time discretization by forward Euler s method φ (k+1) (x) φ (k) (x) t k = v n (k) (x) φ (k) (x). Spatial discretization: Decomposition of normal velocity t φ = v n φ = A + B, parabolic part A = 2γ 0 (H τk) φ, hyperbolic part B = (P 0 ρ 0 U) φ. Central differencing with parameter correction for A = A(φ). Upwinding schemes for B = B(φ). Time step t = 0.5h max x [Trace (C(x))/h + P 0 + 2ρ 0 U(x) ].

12 Introduce P = I φ φ φ 2 : λ = 0, 1, 1, u 1 = φ, u 2, u 3 φ, Π = 1 φ P ( 2 φ ) P : λ = 0, κ 1, κ 2, u 1 = φ, u 2, u 3 φ. Then H = 1 2 Trace Π and K = 1 2 [ (Trace Π) 2 Trace ( Π 2)]. A(φ) = 2γ 0 [H(φ) τk(φ)] φ = γ 0 C(φ) : 2 φ, where a C(φ) = [1 2τH(φ)] P(φ) + τπ(φ) = Q 1 0 a 2 0 Q has eigenvalues a 1 = 1 τκ 1 and a 2 = 1 τκ 2.

13 Linearization of the parabolic part A = A(φ) δa(φ)(ψ) = d dε A(φ + εψ) = γ 0 D(φ) : 2 ψ + E( φ, 2 φ, ψ), ε=0 D(φ) = [1 4τH(φ)] P(φ) + 2τΠ(φ) : λ = 0, 1 2τκ 1, 1 2τκ 2. Recall linearized parabolicity 1 2τκ 1 > 0, 1 2τκ 2 > 0 a A(φ) = γ 0 C(φ) : 2 φ = Q 1 0 a 2 0 Q : 2 φ Eigenvalues of C(φ) : a 1 = 1 τκ 1 and a 2 = 1 τκ 2. Parameter correction to enforce the parabolicity For i = 1, 2: if a i < 0.5 then re-set a i = 0.5.

14 Algorithm (1) Initialization: Input all parameters; Fix a computational box and discretize it with a uniform grid; Compute P0 and ρ 0 U(x) at all grid points except x 1,...,x N ; Generate an initial surface Γ = {x : φ(x) = 0}: a loose wrap (e.g., a large ball) or a tight-wrap, e.g., (2) Local level-set method: φ(x) = min 1 i N ( x x i σ i ). Choose a narrow band around the surface with width grid points. At each grid point in the band, compute φ, 2 φ, H, and K using centered difference schemes. At grid points near the band boundary, use a lower-order scheme.

15 Algorithm (continued) (3) Compute the free energy using f dv = (1 Heav (φ))dv, Ω in R 3 g ds = g φ δ(φ)dv. R 3 Γ (4) Calculate and extend v n φ = A + B. Parameter correction to enforce the parabolicity. Fast sweep to extend P0 and ρ 0 U. A WENO scheme to discretize the extended P0 and ρ 0 U. (5) Calculate the time step t.

16 (6) Reinitialize the level-set function φ by solving φ t + sign(φ 0 )( φ 1) = 0 with sign(φ 0 ) = φ 0 φ 20 + h. About 12 iterations in time. fourth-order Runge-Kutta scheme for time. fifth-order WENO for space. (7) Check the convergence. If not, locate the interface Γ and go to Step (2).

17 3. A Technique of Numerical Integration

18 . x 0 D Ω \ D R 3 \D 1 x x 0 k dv = Ω\D I 1 = Ω\D Ω 1 x x 0 k dv+ 1 x x 0 k dv = Approximate χ Ω\D by a smooth function. Ω R 3 \Ω χ Ω\D (x) x x 0 k dv 1 x x 0 k dv = I 1+I 2 The composite trapezoidal rule for one-dimensional integrals. A second-order accurate scheme.

19 Q x 0 Q 2 x Q 2 ϕ 2 Q 2 x axis Q 1 I 2 = R 3 \Ω Q 1 x x 0 k dv 2 ϕ1 The integral I 2 does not depend on D. Decompose R 3 \ Ω into six regions of two types.

20 Q x 0 Q 2 x Q 2 ϕ 2 Q 2 x axis ˆQ 1 = I 2,1 = Q 1 { (r, θ, z) : 0 < r < ˆQ 1 1 x x 0 k dv = Q 2 ϕ1 β } cos θ, θ 1 < θ < θ 2, L < z < θ2 Integrated analytically in r and z. L θ 1 β cos θ 0 r (r 2 + z 2 dr dθ dz ) k/2 The composite Simpson s rule for the integral in θ.

21 Q x 0 Q 2 x Q 2 ϕ 2 Q 2 x axis Q 1 Q 2 ϕ1 { } α Q 2 = (ρ, ϕ, ψ) : cos ϕ sinψ < ρ <, ϕ 1 < ϕ < ϕ 2, 0 < ψ < π 1 π ϕ2 I 2,2 = Q 2 x x 0 k dv = sinψ dρ dϕ dψ ρk 2 0 ϕ 1 α cos ϕ sin ψ Calculated analytically.

22 4. Convergence Test

23 Γ O R A one-particle system G(R) = 4 ( ) σ 3 P 0πR 3 + 4γ 0 πr γ 0 τπr + 16πρ 0 ǫ 9R 9 σ6 3R 3.

24 6 5.5 LS Exact The total free energy Steps The decay of the free energy with respect to level-set iteration steps.

25 LS Exact Log 2 of the total free energy log 2 1/h The free energy vs. step size in logarithmic scale.

26 5. Application to Molecular Solvation

27 A two-atom system. Cross sections of the free-energy minimizing surfaces at distance d = 4Å (upper left), d = 6Å (upper right), d = 8Å (lower left), and d = 10Å (lower right).

28 Tight initial with distance of 6.6Å Final Loose initial with distance of 6.6Å Tight initial with distance of 7Å Loose initial with distance of 7Å Final Final Final A two-plate system. Cross sections of initial and final surfaces at two different separations d = 6.6Å (left) and d = 7Å (right).

29 300 Dry Wet 350 The total free energy Distance of two plates A two-plate system (continued). The free energy vs. the plate separation distance, showing a hysteresis loop.

30 Topological changes in a system of 5 atoms.

31 A helical polymer. Two different initial surfaces and their corresponding final surfaces.

32 The free-energy minimizing surface of an artificial molecule.

33 6. Conclusions

34 Developed and tested a level-set optimization method Discretization: centered differencing for curvatures, upwinding for lower-order hyperbolic terms Parameter correction: mathematical regularization and physical modeling Tested second-order convergence rate Application to solvation of simple, nonpolar molecules Initial surfaces determine final, free-energy minimizing surfaces Efficiency vs. accuracy.

35 Current work Improve the accuracy lost in the difference of large geometrical and LJ parts of the free energy Speed up the computation Convergence analysis Add the surface integral of the Gaussian curvature Include electrostatics Monte Carlo level-set method for searching local minima Application to large biomolecular systems Reference L.-T. Cheng, B. Li, and Z. Wang, Level-set minimization of potential controlled Hadwiger valuations for molecular solvation, J. Comp. Phys., 2010 (accepted).

36 Thank you!

Level-Set Minimization of Potential Controlled Hadwiger Valuations for Molecular Solvation

Level-Set Minimization of Potential Controlled Hadwiger Valuations for Molecular Solvation Level-Set Minimization of Potential Controlled Hadwiger Valuations for Molecular Solvation Li-Tien Cheng Bo Li Zhongming Wang August 6, Abstract A level-set method is developed for the numerical minimization

More information

Coupling the Level-Set Method with Variational Implicit Solvent Modeling of Molecular Solvation

Coupling the Level-Set Method with Variational Implicit Solvent Modeling of Molecular Solvation Coupling the Level-Set Method with Variational Implicit Solvent Modeling of Molecular Solvation Bo Li Math Dept & CTBP, UCSD Li-Tien Cheng (Math, UCSD) Zhongming Wang (Math & Biochem, UCSD) Yang Xie (MAE,

More information

Level-Set Variational Implicit-Solvent Modeling of Biomolecular Solvation

Level-Set Variational Implicit-Solvent Modeling of Biomolecular Solvation Level-Set Variational Implicit-Solvent Modeling of Biomolecular Solvation Bo Li Department of Mathematics and Quantitative Biology Graduate Program UC San Diego The 7 th International Congress of Chinese

More information

Variational Implicit Solvation of Biomolecules: From Theory to Numerical Computations

Variational Implicit Solvation of Biomolecules: From Theory to Numerical Computations Variational Implicit Solvation of Biomolecules: From Theory to Numerical Computations Bo Li Department of Mathematics and Center for Theoretical Biological Physics UC San Diego CECAM Workshop: New Perspectives

More information

Level-Set Variational Solvation Coupling Solute Molecular Mechanics with Continuum Solvent

Level-Set Variational Solvation Coupling Solute Molecular Mechanics with Continuum Solvent Level-Set Variational Solvation Coupling Solute Molecular Mechanics with Continuum Solvent Bo Li Department of Mathematics and Center for Theoretical Biological Physics (CTBP) University of California,

More information

Level-Set Variational Implicit-Solvent Modeling of Biomolecules with the Coulomb-Field Approximation

Level-Set Variational Implicit-Solvent Modeling of Biomolecules with the Coulomb-Field Approximation Level-Set Variational Implicit-Solvent Modeling of Biomolecules with the Coulomb-Field Approximation Zhongming Wang,, Jianwei Che, 2, Li-Tien Cheng, 3, Joachim Dzubiella, 4, Bo Li, 5, 6, and J. Andrew

More information

Dielectric Boundary in Biomolecular Solvation Bo Li Department of Mathematics and Center for Theoretical Biological Physics UC San Diego

Dielectric Boundary in Biomolecular Solvation Bo Li Department of Mathematics and Center for Theoretical Biological Physics UC San Diego Dielectric Boundary in Biomolecular Solvation Bo Li Department of Mathematics and Center for Theoretical Biological Physics UC San Diego International Conference on Free Boundary Problems Newton Institute,

More information

Motion of a Cylindrical Dielectric Boundary

Motion of a Cylindrical Dielectric Boundary Motion of a Cylindrical Dielectric Boundary Bo Li Department of Mathematics and NSF Center for Theoretical Biological Physics UC San Diego Collaborators Li-Tien Cheng, Michael White, and Shenggao Zhou

More information

Numerical Methods for Solvent Stokes Flow and Solute-Solvent Interfacial Dynamics of Charged Molecules

Numerical Methods for Solvent Stokes Flow and Solute-Solvent Interfacial Dynamics of Charged Molecules Numerical Methods for Solvent Stokes Flow and Solute-Solvent Interfacial Dynamics of Charged Molecules Hui Sun Shenggao Zhou Li-Tien Cheng Bo Li July 30, 2018 Abstract We develop a computational model

More information

Coupling the Level-Set Method with Molecular Mechanics for Variational Implicit Solvation of Nonpolar Molecules

Coupling the Level-Set Method with Molecular Mechanics for Variational Implicit Solvation of Nonpolar Molecules Coupling the Level-Set Method with Molecular Mechanics for Variational Implicit Solvation of Nonpolar Molecules Li-Tien Cheng, 1, Yang Xie, 2, Joachim Dzubiella, 3, J Andrew McCammon, 4, Jianwei Che, 5,

More information

Research Statement. Shenggao Zhou. November 3, 2014

Research Statement. Shenggao Zhou. November 3, 2014 Shenggao Zhou November 3, My research focuses on: () Scientific computing and numerical analysis (numerical PDEs, numerical optimization, computational fluid dynamics, and level-set method for interface

More information

Variational Implicit Solvation: Empowering Mathematics and Computation to Understand Biological Building Blocks

Variational Implicit Solvation: Empowering Mathematics and Computation to Understand Biological Building Blocks Variational Implicit Solvation: Empowering Mathematics and Computation to Understand Biological Building Blocks Bo Li Department of Mathematics and NSF Center for Theoretical Biological Physics UC San

More information

The Poisson Boltzmann Theory and Variational Implicit Solvation of Biomolecules

The Poisson Boltzmann Theory and Variational Implicit Solvation of Biomolecules The Poisson Boltzmann Theory and Variational Implicit Solvation of Biomolecules Bo Li Department of Mathematics and NSF Center for Theoretical Biological Physics (CTBP) UC San Diego FUNDING: NIH, NSF,

More information

Continuum Electrostatics for Ionic Solutions with Nonuniform Ionic Sizes

Continuum Electrostatics for Ionic Solutions with Nonuniform Ionic Sizes Continuum Electrostatics for Ionic Solutions with Nonuniform Ionic Sizes Bo Li Department of Mathematics and Center for Theoretical Biological Physics (CTBP) University of California, San Diego, USA Supported

More information

Numerical Methods of Applied Mathematics -- II Spring 2009

Numerical Methods of Applied Mathematics -- II Spring 2009 MIT OpenCourseWare http://ocw.mit.edu 18.336 Numerical Methods of Applied Mathematics -- II Spring 2009 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms.

More information

Supporting Information

Supporting Information Supporting Information A: Calculation of radial distribution functions To get an effective propagator in one dimension, we first transform 1) into spherical coordinates: x a = ρ sin θ cos φ, y = ρ sin

More information

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

More information

Math 221 Examination 2 Several Variable Calculus

Math 221 Examination 2 Several Variable Calculus Math Examination Spring Instructions These problems should be viewed as essa questions. Before making a calculation, ou should explain in words what our strateg is. Please write our solutions on our own

More information

Segmentation using deformable models

Segmentation using deformable models Segmentation using deformable models Isabelle Bloch http://www.tsi.enst.fr/ bloch Téécom ParisTech - CNRS UMR 5141 LTCI Paris - France Modèles déformables p.1/43 Introduction Deformable models = evolution

More information

Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics

Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI (after: D.J. ACHESON s Elementary Fluid Dynamics ) bluebox.ippt.pan.pl/

More information

A Survey of Computational High Frequency Wave Propagation II. Olof Runborg NADA, KTH

A Survey of Computational High Frequency Wave Propagation II. Olof Runborg NADA, KTH A Survey of Computational High Frequency Wave Propagation II Olof Runborg NADA, KTH High Frequency Wave Propagation CSCAMM, September 19-22, 2005 Numerical methods Direct methods Wave equation (time domain)

More information

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations Hao Li Math Dept, Purdue Univeristy Ocean University of China, December, 2017 Joint work with

More information

Lecture No 1 Introduction to Diffusion equations The heat equat

Lecture No 1 Introduction to Diffusion equations The heat equat Lecture No 1 Introduction to Diffusion equations The heat equation Columbia University IAS summer program June, 2009 Outline of the lectures We will discuss some basic models of diffusion equations and

More information

Practice Final Solutions

Practice Final Solutions Practice Final Solutions Math 1, Fall 17 Problem 1. Find a parameterization for the given curve, including bounds on the parameter t. Part a) The ellipse in R whose major axis has endpoints, ) and 6, )

More information

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Jianxian Qiu School of Mathematical Science Xiamen University jxqiu@xmu.edu.cn http://ccam.xmu.edu.cn/teacher/jxqiu

More information

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws Kilian Cooley 1 Prof. James Baeder 2 1 Department of Mathematics, University of Maryland - College Park 2 Department of Aerospace

More information

arxiv: v1 [math.na] 5 Dec 2017

arxiv: v1 [math.na] 5 Dec 2017 A New Phase-Field Approach to Variational Implicit Solvation of Charged Molecules with the Coulomb-Field Approximation Yanxiang Zhao Department of Mathematics, the George Washington University, 81 22nd

More information

Integrals in cylindrical, spherical coordinates (Sect. 15.7)

Integrals in cylindrical, spherical coordinates (Sect. 15.7) Integrals in clindrical, spherical coordinates (Sect. 15.7 Integration in spherical coordinates. Review: Clindrical coordinates. Spherical coordinates in space. Triple integral in spherical coordinates.

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

1. (a) (5 points) Find the unit tangent and unit normal vectors T and N to the curve. r (t) = 3 cos t, 0, 3 sin t, r ( 3π

1. (a) (5 points) Find the unit tangent and unit normal vectors T and N to the curve. r (t) = 3 cos t, 0, 3 sin t, r ( 3π 1. a) 5 points) Find the unit tangent and unit normal vectors T and N to the curve at the point P 3, 3π, r t) 3 cos t, 4t, 3 sin t 3 ). b) 5 points) Find curvature of the curve at the point P. olution:

More information

Mean-Field Description of Ionic Size Effects

Mean-Field Description of Ionic Size Effects Mean-Field Description of Ionic Size Effects Bo Li Department of Mathematics and NSF Center for Theoretical Biological Physics University of California, San Diego Work Supported by NSF, NIH, CSC, CTBP

More information

Application of the level-set method to the implicit solvation of nonpolar molecules

Application of the level-set method to the implicit solvation of nonpolar molecules Application of the level-set method to the implicit solvation of nonpolar molecules Li-Tien Cheng, 1, Joachim Dzubiella, 2, 3, 4, J. Andrew McCammon, 3, 5, and Bo Li 1, 1 Department of Mathematics, University

More information

A sharp diffuse interface tracking method for approximating evolving interfaces

A sharp diffuse interface tracking method for approximating evolving interfaces A sharp diffuse interface tracking method for approximating evolving interfaces Vanessa Styles and Charlie Elliott University of Sussex Overview Introduction Phase field models Double well and double obstacle

More information

FDM for parabolic equations

FDM for parabolic equations FDM for parabolic equations Consider the heat equation where Well-posed problem Existence & Uniqueness Mass & Energy decreasing FDM for parabolic equations CNFD Crank-Nicolson + 2 nd order finite difference

More information

PDEs in Image Processing, Tutorials

PDEs in Image Processing, Tutorials PDEs in Image Processing, Tutorials Markus Grasmair Vienna, Winter Term 2010 2011 Direct Methods Let X be a topological space and R: X R {+ } some functional. following definitions: The mapping R is lower

More information

Solving PDEs Numerically on Manifolds with Arbitrary Spatial Topologies

Solving PDEs Numerically on Manifolds with Arbitrary Spatial Topologies Solving PDEs Numerically on Manifolds with Arbitrary Spatial Topologies Lee Lindblom Theoretical Astrophysics, Caltech Center for Astrophysics and Space Sciences, UC San Diego. Collaborators: Béla Szilágyi,

More information

MATH 332: Vector Analysis Summer 2005 Homework

MATH 332: Vector Analysis Summer 2005 Homework MATH 332, (Vector Analysis), Summer 2005: Homework 1 Instructor: Ivan Avramidi MATH 332: Vector Analysis Summer 2005 Homework Set 1. (Scalar Product, Equation of a Plane, Vector Product) Sections: 1.9,

More information

Lecture No 2 Degenerate Diffusion Free boundary problems

Lecture No 2 Degenerate Diffusion Free boundary problems Lecture No 2 Degenerate Diffusion Free boundary problems Columbia University IAS summer program June, 2009 Outline We will discuss non-linear parabolic equations of slow diffusion. Our model is the porous

More information

A numerical study of SSP time integration methods for hyperbolic conservation laws

A numerical study of SSP time integration methods for hyperbolic conservation laws MATHEMATICAL COMMUNICATIONS 613 Math. Commun., Vol. 15, No., pp. 613-633 (010) A numerical study of SSP time integration methods for hyperbolic conservation laws Nelida Črnjarić Žic1,, Bojan Crnković 1

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

Modelling of interfaces and free boundaries

Modelling of interfaces and free boundaries University of Regensburg Regensburg, March 2009 Outline 1 Introduction 2 Obstacle problems 3 Stefan problem 4 Shape optimization Introduction What is a free boundary problem? Solve a partial differential

More information

MATH H53 : Final exam

MATH H53 : Final exam MATH H53 : Final exam 11 May, 18 Name: You have 18 minutes to answer the questions. Use of calculators or any electronic items is not permitted. Answer the questions in the space provided. If you run out

More information

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

More information

The heat equation in time dependent domains with Neumann boundary conditions

The heat equation in time dependent domains with Neumann boundary conditions The heat equation in time dependent domains with Neumann boundary conditions Chris Burdzy Zhen-Qing Chen John Sylvester Abstract We study the heat equation in domains in R n with insulated fast moving

More information

On the Convergence of the Concave-Convex Procedure

On the Convergence of the Concave-Convex Procedure On the Convergence of the Concave-Convex Procedure Bharath K. Sriperumbudur and Gert R. G. Lanckriet UC San Diego OPT 2009 Outline Difference of convex functions (d.c.) program Applications in machine

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

Simulation of free surface fluids in incompressible dynamique

Simulation of free surface fluids in incompressible dynamique Simulation of free surface fluids in incompressible dynamique Dena Kazerani INRIA Paris Supervised by Pascal Frey at Laboratoire Jacques-Louis Lions-UPMC Workshop on Numerical Modeling of Liquid-Vapor

More information

Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu

Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu Division of Applied Mathematics Brown University Outline Introduction Maximum-principle-preserving for scalar conservation

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations Semi-Lagrangian Formulations for Linear Advection and Applications to Kinetic Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Chi-Wang Shu Supported by NSF and AFOSR.

More information

Math 210, Final Exam, Spring 2012 Problem 1 Solution. (a) Find an equation of the plane passing through the tips of u, v, and w.

Math 210, Final Exam, Spring 2012 Problem 1 Solution. (a) Find an equation of the plane passing through the tips of u, v, and w. Math, Final Exam, Spring Problem Solution. Consider three position vectors (tails are the origin): u,, v 4,, w,, (a) Find an equation of the plane passing through the tips of u, v, and w. (b) Find an equation

More information

The Geometry of Relativity

The Geometry of Relativity Department of Mathematics Oregon State University http://www.math.oregonstate.edu/~tevian Differential Geometry Definition A topological manifold is a second countable Housdorff space that is locally homeomorphic

More information

On Multigrid for Phase Field

On Multigrid for Phase Field On Multigrid for Phase Field Carsten Gräser (FU Berlin), Ralf Kornhuber (FU Berlin), Rolf Krause (Uni Bonn), and Vanessa Styles (University of Sussex) Interphase 04 Rome, September, 13-16, 2004 Synopsis

More information

Eigenvalues of Collapsing Domains and Drift Laplacian

Eigenvalues of Collapsing Domains and Drift Laplacian Eigenvalues of Collapsing Domains and Drift Laplacian Zhiqin Lu Dedicate to Professor Peter Li on his 60th Birthday Department of Mathematics, UC Irvine, Irvine CA 92697 January 17, 2012 Zhiqin Lu, Dept.

More information

Microlocal analysis and inverse problems Lecture 4 : Uniqueness results in admissible geometries

Microlocal analysis and inverse problems Lecture 4 : Uniqueness results in admissible geometries Microlocal analysis and inverse problems Lecture 4 : Uniqueness results in admissible geometries David Dos Santos Ferreira LAGA Université de Paris 13 Wednesday May 18 Instituto de Ciencias Matemáticas,

More information

Holographic Entanglement Entropy for Surface Operators and Defects

Holographic Entanglement Entropy for Surface Operators and Defects Holographic Entanglement Entropy for Surface Operators and Defects Michael Gutperle UCLA) UCSB, January 14th 016 Based on arxiv:1407.569, 1506.0005, 151.04953 with Simon Gentle and Chrysostomos Marasinou

More information

Euler Characteristic of Two-Dimensional Manifolds

Euler Characteristic of Two-Dimensional Manifolds Euler Characteristic of Two-Dimensional Manifolds M. Hafiz Khusyairi August 2008 In this work we will discuss an important notion from topology, namely Euler Characteristic and we will discuss several

More information

Outline. Math Partial Differential Equations. Fourier Transforms for PDEs. Joseph M. Mahaffy,

Outline. Math Partial Differential Equations. Fourier Transforms for PDEs. Joseph M. Mahaffy, Outline Math 53 - Partial Differential Equations s for PDEs Joseph M. Mahaffy, jmahaffy@mail.sdsu.edu Department of Mathematics and Statistics Dynamical Systems Group Computational Sciences Research Center

More information

Optimal Prediction for Radiative Transfer: A New Perspective on Moment Closure

Optimal Prediction for Radiative Transfer: A New Perspective on Moment Closure Optimal Prediction for Radiative Transfer: A New Perspective on Moment Closure Benjamin Seibold MIT Applied Mathematics Mar 02 nd, 2009 Collaborator Martin Frank (TU Kaiserslautern) Partial Support NSF

More information

Ancient solutions to Ricci flow

Ancient solutions to Ricci flow Ancient solutions to Ricci flow Lei Ni University of California, San Diego 2012 Motivations Motivations Ricci flow equation g(t) = 2Ric(g(t)). t Motivations Ricci flow equation g(t) = 2Ric(g(t)). t An

More information

Approximation of fluid-structure interaction problems with Lagrange multiplier

Approximation of fluid-structure interaction problems with Lagrange multiplier Approximation of fluid-structure interaction problems with Lagrange multiplier Daniele Boffi Dipartimento di Matematica F. Casorati, Università di Pavia http://www-dimat.unipv.it/boffi May 30, 2016 Outline

More information

Computations of Vector Potential and Toroidal Flux and Applications to Stellarator Simulations

Computations of Vector Potential and Toroidal Flux and Applications to Stellarator Simulations Computations of Vector Potential and Toroidal Flux and Applications to Stellarator Simulations NIMROD Team Meeting Torrin Bechtel April 30, 2017 Outline 1 Project Goals and Progress 2 Vector Potential

More information

PICARD S THEOREM STEFAN FRIEDL

PICARD S THEOREM STEFAN FRIEDL PICARD S THEOREM STEFAN FRIEDL Abstract. We give a summary for the proof of Picard s Theorem. The proof is for the most part an excerpt of [F]. 1. Introduction Definition. Let U C be an open subset. A

More information

Discretization of Stochastic Differential Systems With Singular Coefficients Part II

Discretization of Stochastic Differential Systems With Singular Coefficients Part II Discretization of Stochastic Differential Systems With Singular Coefficients Part II Denis Talay, INRIA Sophia Antipolis joint works with Mireille Bossy, Nicolas Champagnat, Sylvain Maire, Miguel Martinez,

More information

Positivity-preserving high order schemes for convection dominated equations

Positivity-preserving high order schemes for convection dominated equations Positivity-preserving high order schemes for convection dominated equations Chi-Wang Shu Division of Applied Mathematics Brown University Joint work with Xiangxiong Zhang; Yinhua Xia; Yulong Xing; Cheng

More information

Multi-Scale Modeling and Simulation of the Growth of Bacterial Colony with Cell-Cell Mechanical Interactions

Multi-Scale Modeling and Simulation of the Growth of Bacterial Colony with Cell-Cell Mechanical Interactions Multi-Scale Modeling and Simulation of the Growth of Bacterial Colony with Cell-Cell Mechanical Interactions Hui Sun Department of Mathematics and Statistics California State University Long Beach SIAM

More information

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A. A. I. Peer a,, A. Gopaul a, M. Z. Dauhoo a, M. Bhuruth a, a Department of Mathematics, University of Mauritius, Reduit,

More information

Improving Boundary Conditions in Time- Domain Self-Force Calculations

Improving Boundary Conditions in Time- Domain Self-Force Calculations Improving Boundary Conditions in Time- Domain Self-Force Calculations Carlos F. Sopuerta Institute of Space Sciences National Spanish Research Council Work in Collaboration with Anil Zenginoğlu (Caltech)

More information

INVARIANCE OF THE LAPLACE OPERATOR.

INVARIANCE OF THE LAPLACE OPERATOR. INVARIANCE OF THE LAPLACE OPERATOR. The goal of this handout is to give a coordinate-free proof of the invariance of the Laplace operator under orthogonal transformations of R n (and to explain what this

More information

Exact Solutions of the Einstein Equations

Exact Solutions of the Einstein Equations Notes from phz 6607, Special and General Relativity University of Florida, Fall 2004, Detweiler Exact Solutions of the Einstein Equations These notes are not a substitute in any manner for class lectures.

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

More information

Variational inequalities for set-valued vector fields on Riemannian manifolds

Variational inequalities for set-valued vector fields on Riemannian manifolds Variational inequalities for set-valued vector fields on Riemannian manifolds Chong LI Department of Mathematics Zhejiang University Joint with Jen-Chih YAO Chong LI (Zhejiang University) VI on RM 1 /

More information

Velocity, Energy and Helicity of Vortex Knots and Unknots. F. Maggioni ( )

Velocity, Energy and Helicity of Vortex Knots and Unknots. F. Maggioni ( ) Velocity, Energy and Helicity of Vortex Knots and Unknots F. Maggioni ( ) Dept. of Mathematics, Statistics, Computer Science and Applications University of Bergamo (ITALY) ( ) joint work with S. Alamri,

More information

Interfaces and Hydrophobic Interactions in Receptor-Ligand Systems: A Level-Set Variational Implicit Solvent Approach

Interfaces and Hydrophobic Interactions in Receptor-Ligand Systems: A Level-Set Variational Implicit Solvent Approach Interfaces and Hydrophobic Interactions in Receptor-Ligand Systems: A Level-Set Variational Implicit Solvent Approach Li-Tien Cheng, 1, Zhongming Wang, 2, 1, 2, 3, Piotr Setny, Joachim Dzubiella, 4, Bo

More information

On the approximation of the principal eigenvalue for a class of nonlinear elliptic operators

On the approximation of the principal eigenvalue for a class of nonlinear elliptic operators On the approximation of the principal eigenvalue for a class of nonlinear elliptic operators Fabio Camilli ("Sapienza" Università di Roma) joint work with I.Birindelli ("Sapienza") I.Capuzzo Dolcetta ("Sapienza")

More information

Baby Skyrmions in AdS 3 and Extensions to (3 + 1) Dimensions

Baby Skyrmions in AdS 3 and Extensions to (3 + 1) Dimensions Baby Skyrmions in AdS 3 and Extensions to (3 + 1) Dimensions Durham University Work in collaboration with Matthew Elliot-Ripley June 26, 2015 Introduction to baby Skyrmions in flat space and AdS 3 Discuss

More information

Allen Cahn Equation in Two Spatial Dimension

Allen Cahn Equation in Two Spatial Dimension Allen Cahn Equation in Two Spatial Dimension Yoichiro Mori April 25, 216 Consider the Allen Cahn equation in two spatial dimension: ɛ u = ɛ2 u + fu) 1) where ɛ > is a small parameter and fu) is of cubic

More information

Exercise 1 (Formula for connection 1-forms) Using the first structure equation, show that

Exercise 1 (Formula for connection 1-forms) Using the first structure equation, show that 1 Stokes s Theorem Let D R 2 be a connected compact smooth domain, so that D is a smooth embedded circle. Given a smooth function f : D R, define fdx dy fdxdy, D where the left-hand side is the integral

More information

Optimal time travel in the Gödel universe

Optimal time travel in the Gödel universe Optimal time travel in the Gödel universe José Natário (Instituto Superior Técnico, Lisbon) Based on arxiv:1105.6197 Porto, January 2013 Outline Newtonian cosmology Rotating Newtonian universe Newton-Cartan

More information

Computing High Frequency Waves By the Level Set Method

Computing High Frequency Waves By the Level Set Method Computing High Frequency Waves By the Level Set Method Hailiang Liu Department of Mathematics Iowa State University Collaborators: Li-Tien Cheng (UCSD), Stanley Osher (UCLA) Shi Jin (UW-Madison), Richard

More information

Properties for systems with weak invariant manifolds

Properties for systems with weak invariant manifolds Statistical properties for systems with weak invariant manifolds Faculdade de Ciências da Universidade do Porto Joint work with José F. Alves Workshop rare & extreme Gibbs-Markov-Young structure Let M

More information

Contents. MATH 32B-2 (18W) (L) G. Liu / (TA) A. Zhou Calculus of Several Variables. 1 Multiple Integrals 3. 2 Vector Fields 9

Contents. MATH 32B-2 (18W) (L) G. Liu / (TA) A. Zhou Calculus of Several Variables. 1 Multiple Integrals 3. 2 Vector Fields 9 MATH 32B-2 (8W) (L) G. Liu / (TA) A. Zhou Calculus of Several Variables Contents Multiple Integrals 3 2 Vector Fields 9 3 Line and Surface Integrals 5 4 The Classical Integral Theorems 9 MATH 32B-2 (8W)

More information

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation Chapter 3. Finite Difference Methods for Hyperbolic Equations 3.1. Introduction Most hyperbolic problems involve the transport of fluid properties. In the equations of motion, the term describing the transport

More information

PHY6426/Fall 07: CLASSICAL MECHANICS HOMEWORK ASSIGNMENT #1 due by 9:35 a.m. Wed 09/05 Instructor: D. L. Maslov Rm.

PHY6426/Fall 07: CLASSICAL MECHANICS HOMEWORK ASSIGNMENT #1 due by 9:35 a.m. Wed 09/05 Instructor: D. L. Maslov Rm. PHY646/Fall 07: CLASSICAL MECHANICS HOMEWORK ASSIGNMENT # due by 9:35 a.m. Wed 09/05 Instructor: D. L. Maslov maslov@phys.ufl.edu 39-053 Rm. 4 Please help your instructor by doing your work neatly.. Goldstein,

More information

Rectifiability of sets and measures

Rectifiability of sets and measures Rectifiability of sets and measures Tatiana Toro University of Washington IMPA February 7, 206 Tatiana Toro (University of Washington) Structure of n-uniform measure in R m February 7, 206 / 23 State of

More information

Fast-slow systems with chaotic noise

Fast-slow systems with chaotic noise Fast-slow systems with chaotic noise David Kelly Ian Melbourne Courant Institute New York University New York NY www.dtbkelly.com May 1, 216 Statistical properties of dynamical systems, ESI Vienna. David

More information

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2 Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer ringhofer@asu.edu, C2 b 2 2 h2 x u http://math.la.asu.edu/ chris Last update: Jan 24, 2006 1 LITERATURE 1. Numerical Methods for Conservation

More information

MATHS 267 Answers to Stokes Practice Dr. Jones

MATHS 267 Answers to Stokes Practice Dr. Jones MATH 267 Answers to tokes Practice Dr. Jones 1. Calculate the flux F d where is the hemisphere x2 + y 2 + z 2 1, z > and F (xz + e y2, yz, z 2 + 1). Note: the surface is open (doesn t include any of the

More information

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

Rigidity and Non-rigidity Results on the Sphere

Rigidity and Non-rigidity Results on the Sphere Rigidity and Non-rigidity Results on the Sphere Fengbo Hang Xiaodong Wang Department of Mathematics Michigan State University Oct., 00 1 Introduction It is a simple consequence of the maximum principle

More information

Nonlinear elasticity and gels

Nonlinear elasticity and gels Nonlinear elasticity and gels M. Carme Calderer School of Mathematics University of Minnesota New Mexico Analysis Seminar New Mexico State University April 4-6, 2008 1 / 23 Outline Balance laws for gels

More information

Numerical Methods in Physics and Astrophysics

Numerical Methods in Physics and Astrophysics Kostas Kokkotas 2 October 20, 2014 2 http://www.tat.physik.uni-tuebingen.de/ kokkotas Kostas Kokkotas 3 TOPICS 1. Solving nonlinear equations 2. Solving linear systems of equations 3. Interpolation, approximation

More information

MATH DIFFERENTIAL GEOMETRY. Contents

MATH DIFFERENTIAL GEOMETRY. Contents MATH 3968 - DIFFERENTIAL GEOMETRY ANDREW TULLOCH Contents 1. Curves in R N 2 2. General Analysis 2 3. Surfaces in R 3 3 3.1. The Gauss Bonnet Theorem 8 4. Abstract Manifolds 9 1 MATH 3968 - DIFFERENTIAL

More information

Problem Set 5 Math 213, Fall 2016

Problem Set 5 Math 213, Fall 2016 Problem Set 5 Math 213, Fall 216 Directions: Name: Show all your work. You are welcome and encouraged to use Mathematica, or similar software, to check your answers and aid in your understanding of the

More information

Chapter 4. Multiple Integrals. 1. Integrals on Rectangles

Chapter 4. Multiple Integrals. 1. Integrals on Rectangles Chapter 4. Multiple Integrals Let be a rectangle in I 2 given by 1. Integrals on ectangles = [a 1, b 1 [a 2, b 2 := {(x, y) I 2 : a 1 x b 1, a 2 y b 2 }. Let P 1 be a partition of [a 1, b 1 : P 1 : a 1

More information

A general well-balanced finite volume scheme for Euler equations with gravity

A general well-balanced finite volume scheme for Euler equations with gravity A general well-balanced finite volume scheme for Euler equations with gravity Jonas P. Berberich, Praveen Chandrashekar, Christian Klingenberg Abstract We present a second order well-balanced Godunov-type

More information

Numerical Simulation of Rarefied Gases using Hyperbolic Moment Equations in Partially-Conservative Form

Numerical Simulation of Rarefied Gases using Hyperbolic Moment Equations in Partially-Conservative Form Numerical Simulation of Rarefied Gases using Hyperbolic Moment Equations in Partially-Conservative Form Julian Koellermeier, Manuel Torrilhon May 18th, 2017 FU Berlin J. Koellermeier 1 / 52 Partially-Conservative

More information

Math 350 Solutions for Final Exam Page 1. Problem 1. (10 points) (a) Compute the line integral. F ds C. z dx + y dy + x dz C

Math 350 Solutions for Final Exam Page 1. Problem 1. (10 points) (a) Compute the line integral. F ds C. z dx + y dy + x dz C Math 35 Solutions for Final Exam Page Problem. ( points) (a) ompute the line integral F ds for the path c(t) = (t 2, t 3, t) with t and the vector field F (x, y, z) = xi + zj + xk. (b) ompute the line

More information

GRAVITY DUALS OF 2D SUSY GAUGE THEORIES

GRAVITY DUALS OF 2D SUSY GAUGE THEORIES GRAVITY DUALS OF 2D SUSY GAUGE THEORIES BASED ON: 0909.3106 with E. Conde and A.V. Ramallo (Santiago de Compostela) [See also 0810.1053 with C. Núñez, P. Merlatti and A.V. Ramallo] Daniel Areán Milos,

More information