Numerical simulation of the Gross-Pitaevskii equation by pseudo-spectral and finite element methods comparison of GPS code and FreeFem++

Size: px
Start display at page:

Download "Numerical simulation of the Gross-Pitaevskii equation by pseudo-spectral and finite element methods comparison of GPS code and FreeFem++"

Transcription

1 . p.1/13 10 ec. 2014, LJLL, Paris FreeFem++ workshop : BECASIM session Numerical simulation of the Gross-Pitaevskii equation by pseudo-spectral and finite element methods comparison of GPS code and FreeFem++ Atsushi Suzuki LJLL, INRIA-Nancy

2 stationary state of Gross-Pitaevskii equation 1/3 time-dependent Gross-Pitaevskii equation in 2, R 2 i t φ(t) = 1 2 φ(t) Ωi` y φ(t) + V φ(t) + β φ(t) 2 φ(t) in (0, T) φ(0, ) = φ 0 stationary state is given by the minimization of the energy φ H0(, 1 C) 1 E(φ) = 2 φ 2 + V φ 2 + β 2 φ 4 y Ωi` φ φ min E(φ). φ =1 Remark on energy of the angular momentum term R ` y φ φ R (y x φ x y φ) φ = ( x (y φ) y (x φ))φ + = {x ; x < R} `n x n y = `x y /R on y nx x n y = 0. Re (y x φ x y φ) φ = 0 (y n x x n y )φ φ. p.2/13

3 . p.3/13 stationary state of Gross-Pitaevskii equation 2/3 minimization problem E(φ) = min E(φ). φ =1 equivalent nonlinear eigen value problem 1 2 φ 2 + V φ 2 + β 2 φ 4 Ωi` y φ φ find λ R, φ H0 1 ( ; C) λφ = 1 2 φ Ωi` y φ + V φ + β φ 2 φ φ = 1 λ : chemical potential λ = λφ φ = =E(φ) + β 2 φ 4 φ φ Ωi` y φ φ + V φ φ + β φ 2 φ φ

4 . p.4/13 stationary state of Gross-Pitaevskii equation 3/3 minimization problem E(φ) = min E(φ). φ =1 1 2 φ 2 + V φ 2 + β 2 φ 4 Ωi` y φ φ normalized gradient flow ( imaginary time method : i t t ) φ t = 1 2 E(φ) φ φ(t n+1, ) = φ(t n+1, ) φ(t n+1, ) φ(0, ) = φ 0, φ 0 = 1 = φ + Ωi` y φ V φ β φ 2 φ t [t n, t n+1 ) potential α = 1.2, κ = 0.3 V (x, y) = 1 α 2 (x 2 + y 2 ) + κ 4 (x2 + y 2 ) 2 appropriate initial condition : Thomas-Fermi approximation

5 . p.5/13 discretization scheme semi-implicit Euler scheme for time discretization φ n+1 φ n t φ n+1 = = φ n+1 y + Ωi` x φn+1 V φ n+1 β φ n 2 φn+1 φ n+1 φ n+1 φ 0 = φ 0, φ 0 = 1 Space discretization pseudo-spectral method expansion by Fourier basis + collocation method finite element method P1 element + mesh adaptation by FreeFem++

6 . p.6/13 pseudo-spectral method 1/2 = ( π, π) ( π, π) and assume φ is periodic in x- and y-directions expansion by Fourier basis φ(x, y) P ˆφ N/2 k<n/2 k (y)e i kx ˆφ k (y) = 1 2π 1 2π R π π 2π N φ(x, y)e i kx P 0 p<n φ(x p, y)e i kx p, x p = π + 2π N p xφ(x, 2 y) = x 2 Pk ˆφ k (y)e i kx = P k ( k2 )ˆφ k (y)e i kx y x φ(x, y) = y x Pk ˆφ k (y)e i kx = y P k i kˆφ k (y)e i kx at collocation points (x r, y s ) ( same as integration points ) 1 t 1 2 Ωi` y r x s + V (xr, y s ) + β φ n r,s 2 acts to φ n+1 r,s and it is evaluated using xφ(x, 2 y) (xr,y s ) = P k ( k2 ) 1 P N p φ p,se i kx pe i kx r y x φ(x, y) (xr,y s ) = y s Pk i k 1 P N p φ p,se i kx pe i kx r these computations are realized by 1 FFT (fftw library)

7 . p.7/13 pseudo-spectral method 2/2 The operator on collocation points (x r, y s ) ( 1 t 1 2 Ωi` y r x + V (xr, y s s ) + β φ n r,s 2 )φ n+1 r,s collocation method for angular momentum, potential and nonlinear interaction terms simplifies the code there is no explicit matrix expression of the linear operator. The matrix is dense because of forward and backward FFTs. Linear solver Krylov subspace method with Thomas-Fermi preconditioner (X. Antoine, R. uboscq) (P r,s ) 1 = ( 1 t + V (x r, y s ) + β φ n r,s 2 ) 1 GPS code (P. Parnaudeau, J-M. Sac-Epée, A. Suzuki) BiCGStab, GCR solver written by Fortran90 using fftw and OpenMP + MPI (for 3) cut-off with some radius to satisfy homogeneous irichlet boundary conditions parallelization technique is encapsulated in vector-matrix product and inner product

8 finite element method real dt=0.005, alpha=1.2,kappa=0.3; func V=(1.0-alpha)/2.0*(x*x+y*y)+kappa/4.0*(x*x+y*y)*(x*x+y*y); real Omega=3.5, beta=1000.0; func Vtrap=(x*x+y*y)*0.5; real mutf=sqrt(beta/pi); func rhotf=max(0.0,(mutf-vtrap)/beta); fespace Vh(Th,P1); Vh<complex> u,v,u0; Vh zz; u0=sqrt(rhotf); varf gpe(u,v)=int2d(th)(1.0/dt*u*conj(v) +0.5*(dx(u)*conj(dx(v))+dy(u)*conj(dy(v))) -Omega*1i*(y*dx(u)-x*dy(u))*conj(v) +(V+beta*u0*conj(u0))*u*conj(v))+on(1,u=0.0); varf rhs(u,v)=int2d(th)(1.0/dt*u0*conj(v))+on(1,u=0.0); for (int it=0; it < 10000; ++it) { matrix<complex> A=gpe(Vh,Vh,tgv=-1); set(a,solver=sparsesolver,tgv=-1); complex[int] b=rhs(0,vh,tgv=-1); complex[int] w=aˆ-1*b; zz=real(u0)*real(u0)+imag(u0)*imag(u0); u0=u0/sqrt(int2d(th)(zz)); }. p.8/13

9 mesh adaptation after some time steps. p.9/13

10 . p.10/13 Comparison of performance FreeFem++, UMFPACK t = 0.005, n = 274, matrix build RHS build factorization fw/bw subst. energy comput. # CPU FreeFem++, dissection t = 0.005, n = 274, GPS/fftw, t = 0.005, n = 512 2, #itr GCR= / / GPS/fftw, t = , n = 512 2, #itr GCR= / / mac mini 2012, Intel Core i7 2.3GHz + 16G mem. Intel ifort

11 . p.11/13 Newton-Raphson method for nonlinear eigen value problem 1/3 Is stationary state obtained by gradient flow? dependence of stationary state on the initial condition seems to be not clear. How to understand stationary state? Newton-Raphson nonlinear solver approach F 1 (φ, λ) := λφ φ + Ω i` y φ V φ β φ 2 φ F 2 (φ, λ) := λ( φ 2 1) `φ0 0 λ : given by gradient flow solution, with computing λ 0 as chemical potential loop n = 0, 1,2, find `δ ε by solving a linear system: (λ n Ω i` y V 2β φ n 2 )δ β(φ n ) 2 δ + εφ n = F 1 (φ n, λ n ) λ n ( φ n δ + φ n δ) + ε( φ n 2 1) = F 2 (φ n, λ n ) `φn+1 n+1 λ = `φn n λ `δ ε

12 . p.12/13 Newton-Raphson method for nonlinear eigen value problem 2/3 Linear system with (N + 1) (N + 1) matrix (λ n Ω i` y V 2β φ n 2 )δ β(φ n ) 2 δ + εφ n = F 1 (φ n, λ n ) λ n ( φ n δ + φ n δ) + ε( φ n 2 1) = F 2 (φ n, λ n ) block factorization strategy using N N linear solver: solve two linear systems (λ n Ω i` y x V 2β φ n 2 )σ β(φ n ) 2 σ = φ n (λ n Ω i` y V 2β φ n 2 )γ β(φ n ) 2 γ = F 1 (φ n, λ n ) solve Schur complement problem sε = λ n ( φ n 2 1) λ n backward substitution φ n γ + φ n γ (λ n Ω i` y x V 2β φ n 2 )γ β(φ n ) 2 γ = F 1 (φ n, λ n ) εφ n

13 . p.13/13 Newton-Raphson method for nonlinear eigen value problem 3/ l2 norm of updating iteration E(φ) λ # vortex GPS FreeFem

Numerical methods for computing vortex states in rotating Bose-Einstein condensates. Ionut Danaila

Numerical methods for computing vortex states in rotating Bose-Einstein condensates. Ionut Danaila Numerical methods for computing vortex states in rotating Bose-Einstein condensates Ionut Danaila Laboratoire de mathématiques Raphaël Salem Université de Rouen www.univ-rouen.fr/lmrs/persopage/danaila

More information

Contents. Xavier ANTOINE Romain DUBOSCQ. 1 Introduction 2

Contents. Xavier ANTOINE Romain DUBOSCQ. 1 Introduction 2 Robust and efficient preconditioned Krylov spectral solvers for computing the ground states and dynamics of fast rotating and strongly interacting Bose-Einstein condensates Xavier ANTOINE Romain DUBOSCQ

More information

Numerical simulation of Bose-Einstein Condensates based on Gross-Pitaevskii Equations

Numerical simulation of Bose-Einstein Condensates based on Gross-Pitaevskii Equations 1/38 Numerical simulation of Bose-Einstein Condensates based on Gross-Pitaevskii Equations Xavier ANTOINE Institut Elie Cartan de Lorraine (IECL) & Inria-SPHINX Team Université de Lorraine, France Funded

More information

A dissection solver with kernel detection for unsymmetric matrices in FreeFem++

A dissection solver with kernel detection for unsymmetric matrices in FreeFem++ . p.1/21 11 Dec. 2014, LJLL, Paris FreeFem++ workshop A dissection solver with kernel detection for unsymmetric matrices in FreeFem++ Atsushi Suzuki Atsushi.Suzuki@ann.jussieu.fr Joint work with François-Xavier

More information

Xavier Antoine, Antoine Levitt, Qinglin Tang. To cite this version: HAL Id: hal

Xavier Antoine, Antoine Levitt, Qinglin Tang. To cite this version: HAL Id: hal Efficient spectral computation of the stationary states of rotating Bose-Einstein condensates by the preconditioned nonlinear conjugate gradient method Xavier Antoine, Antoine Levitt, Qinglin Tang To cite

More information

16. Solution of elliptic partial differential equation

16. Solution of elliptic partial differential equation 16. Solution of elliptic partial differential equation Recall in the first lecture of this course. Assume you know how to use a computer to compute; but have not done any serious numerical computations

More information

Contents. Preface... xi. Introduction...

Contents. Preface... xi. Introduction... Contents Preface... xi Introduction... xv Chapter 1. Computer Architectures... 1 1.1. Different types of parallelism... 1 1.1.1. Overlap, concurrency and parallelism... 1 1.1.2. Temporal and spatial parallelism

More information

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

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

Parallelism in FreeFem++.

Parallelism in FreeFem++. Parallelism in FreeFem++. Guy Atenekeng 1 Frederic Hecht 2 Laura Grigori 1 Jacques Morice 2 Frederic Nataf 2 1 INRIA, Saclay 2 University of Paris 6 Workshop on FreeFem++, 2009 Outline 1 Introduction Motivation

More information

Recent advances in HPC with FreeFem++

Recent advances in HPC with FreeFem++ Recent advances in HPC with FreeFem++ Pierre Jolivet Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann Fourth workshop on FreeFem++ December 6, 2012 With F. Hecht, F. Nataf, C. Prud homme. Outline

More information

Finite element programming by FreeFem++ advanced course

Finite element programming by FreeFem++ advanced course 1 / 37 Finite element programming by FreeFem++ advanced course Atsushi Suzuki 1 1 Cybermedia Center, Osaka University atsushi.suzuki@cas.cmc.osaka-u.ac.jp Japan SIAM tutorial 4-5, June 2016 2 / 37 Outline

More information

Nonlinear Iterative Solution of the Neutron Transport Equation

Nonlinear Iterative Solution of the Neutron Transport Equation Nonlinear Iterative Solution of the Neutron Transport Equation Emiliano Masiello Commissariat à l Energie Atomique de Saclay /DANS//SERMA/LTSD emiliano.masiello@cea.fr 1/37 Outline - motivations and framework

More information

Xavier Antoine, Romain Duboscq. To cite this version: HAL Id: hal

Xavier Antoine, Romain Duboscq. To cite this version: HAL Id: hal Robust and efficient preconditioned Krylov spectral solvers for computing the ground states of fast rotating and strongly interacting Bose-Einstein condensates Xavier Antoine, Romain Duboscq To cite this

More information

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU Preconditioning Techniques for Solving Large Sparse Linear Systems Arnold Reusken Institut für Geometrie und Praktische Mathematik RWTH-Aachen OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative

More information

A Newton-Galerkin-ADI Method for Large-Scale Algebraic Riccati Equations

A Newton-Galerkin-ADI Method for Large-Scale Algebraic Riccati Equations A Newton-Galerkin-ADI Method for Large-Scale Algebraic Riccati Equations Peter Benner Max-Planck-Institute for Dynamics of Complex Technical Systems Computational Methods in Systems and Control Theory

More information

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing FEniCS Course Lecture 6: Incompressible Navier Stokes Contributors Anders Logg André Massing 1 / 11 The incompressible Navier Stokes equations u + u u ν u + p = f in Ω (0, T ] u = 0 in Ω (0, T ] u = g

More information

Numerical behavior of inexact linear solvers

Numerical behavior of inexact linear solvers Numerical behavior of inexact linear solvers Miro Rozložník joint results with Zhong-zhi Bai and Pavel Jiránek Institute of Computer Science, Czech Academy of Sciences, Prague, Czech Republic The fourth

More information

Preliminary Results of GRAPES Helmholtz solver using GCR and PETSc tools

Preliminary Results of GRAPES Helmholtz solver using GCR and PETSc tools Preliminary Results of GRAPES Helmholtz solver using GCR and PETSc tools Xiangjun Wu (1),Lilun Zhang (2),Junqiang Song (2) and Dehui Chen (1) (1) Center for Numerical Weather Prediction, CMA (2) School

More information

A short introduction to FreeFem++

A short introduction to FreeFem++ A short introduction to FreeFem++ M. Ersoy Basque Center for Applied Mathematics 12 November 2010 Outline of the talk Outline of the talk 1 Introduction 2 HOW TO solve steady pdes : e.g. Laplace equation

More information

TAU Solver Improvement [Implicit methods]

TAU Solver Improvement [Implicit methods] TAU Solver Improvement [Implicit methods] Richard Dwight Megadesign 23-24 May 2007 Folie 1 > Vortrag > Autor Outline Motivation (convergence acceleration to steady state, fast unsteady) Implicit methods

More information

Lecture IV: Time Discretization

Lecture IV: Time Discretization Lecture IV: Time Discretization Motivation Kinematics: continuous motion in continuous time Computer simulation: Discrete time steps t Discrete Space (mesh particles) Updating Position Force induces acceleration.

More information

Dissection sparse direct solver for indefinite finite element matrices and application to a semi-conductor problem

Dissection sparse direct solver for indefinite finite element matrices and application to a semi-conductor problem 10th FreeFem++ days 2018, 13 Dec. Dissection sparse direct solver for indefinite finite element matrices and application to a semi-conductor problem Atsushi Suzuki 1 1 Cybermedia Center, Osaka University

More information

Block Iterative Eigensolvers for Sequences of Dense Correlated Eigenvalue Problems

Block Iterative Eigensolvers for Sequences of Dense Correlated Eigenvalue Problems Mitglied der Helmholtz-Gemeinschaft Block Iterative Eigensolvers for Sequences of Dense Correlated Eigenvalue Problems Birkbeck University, London, June the 29th 2012 Edoardo Di Napoli Motivation and Goals

More information

A uniformly convergent numerical method for singularly perturbed nonlinear eigenvalue problems

A uniformly convergent numerical method for singularly perturbed nonlinear eigenvalue problems A uniformly convergent numerical method for singularly perturbed nonlinear eigenvalue problems Weizhu Bao and Ming-Huang Chai Abstract In this paper we propose a uniformly convergent numerical method for

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Lecture V: The game-engine loop & Time Integration

Lecture V: The game-engine loop & Time Integration Lecture V: The game-engine loop & Time Integration The Basic Game-Engine Loop Previous state: " #, %(#) ( #, )(#) Forces -(#) Integrate velocities and positions Resolve Interpenetrations Per-body change

More information

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D Luc Giraud N7-IRIT, Toulouse MUMPS Day October 24, 2006, ENS-INRIA, Lyon, France Outline 1 General Framework 2 The direct

More information

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Timo Heister, Texas A&M University 2013-02-28 SIAM CSE 2 Setting Stationary, incompressible flow problems

More information

Sensitivity analysis by adjoint Automatic Differentiation and Application

Sensitivity analysis by adjoint Automatic Differentiation and Application Sensitivity analysis by adjoint Automatic Differentiation and Application Anca Belme Massimiliano Martinelli Laurent Hascoët Valérie Pascual Alain Dervieux INRIA Sophia-Antipolis Project TROPICS Alain.Dervieux@inria.fr

More information

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

More information

THE solution of the absolute value equation (AVE) of

THE solution of the absolute value equation (AVE) of The nonlinear HSS-like iterative method for absolute value equations Mu-Zheng Zhu Member, IAENG, and Ya-E Qi arxiv:1403.7013v4 [math.na] 2 Jan 2018 Abstract Salkuyeh proposed the Picard-HSS iteration method

More information

Evolution equations with spectral methods: the case of the wave equation

Evolution equations with spectral methods: the case of the wave equation Evolution equations with spectral methods: the case of the wave equation Jerome.Novak@obspm.fr Laboratoire de l Univers et de ses Théories (LUTH) CNRS / Observatoire de Paris, France in collaboration with

More information

Parallel Numerics, WT 2016/ Iterative Methods for Sparse Linear Systems of Equations. page 1 of 1

Parallel Numerics, WT 2016/ Iterative Methods for Sparse Linear Systems of Equations. page 1 of 1 Parallel Numerics, WT 2016/2017 5 Iterative Methods for Sparse Linear Systems of Equations page 1 of 1 Contents 1 Introduction 1.1 Computer Science Aspects 1.2 Numerical Problems 1.3 Graphs 1.4 Loop Manipulations

More information

Efficient BDF time discretization of the Navier Stokes equations with VMS LES modeling in a High Performance Computing framework

Efficient BDF time discretization of the Navier Stokes equations with VMS LES modeling in a High Performance Computing framework Introduction VS LES/BDF Implementation Results Conclusions Swiss Numerical Analysis Day 2015, Geneva, Switzerland, 17 April 2015. Efficient BDF time discretization of the Navier Stokes equations with VS

More information

The Newton-ADI Method for Large-Scale Algebraic Riccati Equations. Peter Benner.

The Newton-ADI Method for Large-Scale Algebraic Riccati Equations. Peter Benner. The Newton-ADI Method for Large-Scale Algebraic Riccati Equations Mathematik in Industrie und Technik Fakultät für Mathematik Peter Benner benner@mathematik.tu-chemnitz.de Sonderforschungsbereich 393 S

More information

Preconditioning for Nonsymmetry and Time-dependence

Preconditioning for Nonsymmetry and Time-dependence Preconditioning for Nonsymmetry and Time-dependence Andy Wathen Oxford University, UK joint work with Jen Pestana and Elle McDonald Jeju, Korea, 2015 p.1/24 Iterative methods For self-adjoint problems/symmetric

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Numerical Modelling in Fortran: day 10. Paul Tackley, 2016

Numerical Modelling in Fortran: day 10. Paul Tackley, 2016 Numerical Modelling in Fortran: day 10 Paul Tackley, 2016 Today s Goals 1. Useful libraries and other software 2. Implicit time stepping 3. Projects: Agree on topic (by final lecture) (No lecture next

More information

FEAST eigenvalue algorithm and solver: review and perspectives

FEAST eigenvalue algorithm and solver: review and perspectives FEAST eigenvalue algorithm and solver: review and perspectives Eric Polizzi Department of Electrical and Computer Engineering University of Masachusetts, Amherst, USA Sparse Days, CERFACS, June 25, 2012

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

Preconditioners for the incompressible Navier Stokes equations

Preconditioners for the incompressible Navier Stokes equations Preconditioners for the incompressible Navier Stokes equations C. Vuik M. ur Rehman A. Segal Delft Institute of Applied Mathematics, TU Delft, The Netherlands SIAM Conference on Computational Science and

More information

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Marcella Bonazzoli 2, Victorita Dolean 1,4, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier

More information

Hierarchical Parallel Solution of Stochastic Systems

Hierarchical Parallel Solution of Stochastic Systems Hierarchical Parallel Solution of Stochastic Systems Second M.I.T. Conference on Computational Fluid and Solid Mechanics Contents: Simple Model of Stochastic Flow Stochastic Galerkin Scheme Resulting Equations

More information

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems: Non-Linear Dynamics Part I

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems: Non-Linear Dynamics Part I The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems: Non-Linear Dynamics Part I Prof. Dr. Eleni Chatzi Dr. Giuseppe Abbiati, Dr. Konstantinos Agathos Lecture 5/Part A - 23 November,

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

MATHEMATICAL METHODS INTERPOLATION

MATHEMATICAL METHODS INTERPOLATION MATHEMATICAL METHODS INTERPOLATION I YEAR BTech By Mr Y Prabhaker Reddy Asst Professor of Mathematics Guru Nanak Engineering College Ibrahimpatnam, Hyderabad SYLLABUS OF MATHEMATICAL METHODS (as per JNTU

More information

A parameter tuning technique of a weighted Jacobi-type preconditioner and its application to supernova simulations

A parameter tuning technique of a weighted Jacobi-type preconditioner and its application to supernova simulations A parameter tuning technique of a weighted Jacobi-type preconditioner and its application to supernova simulations Akira IMAKURA Center for Computational Sciences, University of Tsukuba Joint work with

More information

A Level Set Based. Finite Element Algorithm. for Image Segmentation

A Level Set Based. Finite Element Algorithm. for Image Segmentation A Level Set Based Finite Element Algorithm for Image Segmentation Michael Fried, IAM Universität Freiburg, Germany Image Segmentation Ω IR n rectangular domain, n = (1), 2, 3 u 0 : Ω [0, C max ] intensity

More information

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics SPARSE SOLVERS FOR THE POISSON EQUATION Margreet Nool CWI, Multiscale Dynamics November 9, 2015 OUTLINE OF THIS TALK 1 FISHPACK, LAPACK, PARDISO 2 SYSTEM OVERVIEW OF CARTESIUS 3 POISSON EQUATION 4 SOLVERS

More information

Third Critical Speed for Rotating Bose-Einstein Condensates. Mathematical Foundations of Physics Daniele Dimonte, SISSA

Third Critical Speed for Rotating Bose-Einstein Condensates. Mathematical Foundations of Physics Daniele Dimonte, SISSA Third Critical Speed for Rotating Bose-Einstein Condensates Mathematical Foundations of Physics Daniele Dimonte, SISSA 1 st November 2016 this presentation available on daniele.dimonte.it based on a joint

More information

Lecture 8: Fast Linear Solvers (Part 7)

Lecture 8: Fast Linear Solvers (Part 7) Lecture 8: Fast Linear Solvers (Part 7) 1 Modified Gram-Schmidt Process with Reorthogonalization Test Reorthogonalization If Av k 2 + δ v k+1 2 = Av k 2 to working precision. δ = 10 3 2 Householder Arnoldi

More information

Elmer. Introduction into Elmer multiphysics. Thomas Zwinger. CSC Tieteen tietotekniikan keskus Oy CSC IT Center for Science Ltd.

Elmer. Introduction into Elmer multiphysics. Thomas Zwinger. CSC Tieteen tietotekniikan keskus Oy CSC IT Center for Science Ltd. Elmer Introduction into Elmer multiphysics FEM package Thomas Zwinger CSC Tieteen tietotekniikan keskus Oy CSC IT Center for Science Ltd. Contents Elmer Background History users, community contacts and

More information

Faster Kinetics: Accelerate Your Finite-Rate Combustion Simulation with GPUs

Faster Kinetics: Accelerate Your Finite-Rate Combustion Simulation with GPUs Faster Kinetics: Accelerate Your Finite-Rate Combustion Simulation with GPUs Christopher P. Stone, Ph.D. Computational Science and Engineering, LLC Kyle Niemeyer, Ph.D. Oregon State University 2 Outline

More information

A monolithic FEM solver for fluid structure

A monolithic FEM solver for fluid structure A monolithic FEM solver for fluid structure interaction p. 1/1 A monolithic FEM solver for fluid structure interaction Stefan Turek, Jaroslav Hron jaroslav.hron@mathematik.uni-dortmund.de Department of

More information

The spectral transform method

The spectral transform method The spectral transform method by Nils Wedi European Centre for Medium-Range Weather Forecasts wedi@ecmwf.int Advanced Numerical Methods for Earth-System Modelling Slide 1 Advanced Numerical Methods for

More information

An Accelerated Block-Parallel Newton Method via Overlapped Partitioning

An Accelerated Block-Parallel Newton Method via Overlapped Partitioning An Accelerated Block-Parallel Newton Method via Overlapped Partitioning Yurong Chen Lab. of Parallel Computing, Institute of Software, CAS (http://www.rdcps.ac.cn/~ychen/english.htm) Summary. This paper

More information

Controllability of linear PDEs (I): The wave equation

Controllability of linear PDEs (I): The wave equation Controllability of linear PDEs (I): The wave equation M. González-Burgos IMUS, Universidad de Sevilla Doc Course, Course 2, Sevilla, 2018 Contents 1 Introduction. Statement of the problem 2 Distributed

More information

MA/CS 615 Spring 2019 Homework #2

MA/CS 615 Spring 2019 Homework #2 MA/CS 615 Spring 019 Homework # Due before class starts on Feb 1. Late homework will not be given any credit. Collaboration is OK but not encouraged. Indicate on your report whether you have collaborated

More information

Fast Methods for Integral Equations. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy

Fast Methods for Integral Equations. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Introduction to Simulation - Lecture 23 Fast Methods for Integral Equations Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Solving Discretized Integral Equations Using

More information

Consistency analysis of a 1D Finite Volume scheme for barotropic Euler models

Consistency analysis of a 1D Finite Volume scheme for barotropic Euler models Consistency analysis of a 1D Finite Volume scheme for barotropic Euler models F Berthelin 1,3, T Goudon 1,3, and S Mineaud,3 1 Inria, Sophia Antipolis Méditerranée Research Centre, Proect COFFEE Inria,

More information

1. Fourier Transform (Continuous time) A finite energy signal is a signal f(t) for which. f(t) 2 dt < Scalar product: f(t)g(t)dt

1. Fourier Transform (Continuous time) A finite energy signal is a signal f(t) for which. f(t) 2 dt < Scalar product: f(t)g(t)dt 1. Fourier Transform (Continuous time) 1.1. Signals with finite energy A finite energy signal is a signal f(t) for which Scalar product: f(t) 2 dt < f(t), g(t) = 1 2π f(t)g(t)dt The Hilbert space of all

More information

Indefinite and physics-based preconditioning

Indefinite and physics-based preconditioning Indefinite and physics-based preconditioning Jed Brown VAW, ETH Zürich 2009-01-29 Newton iteration Standard form of a nonlinear system F (u) 0 Iteration Solve: Update: J(ũ)u F (ũ) ũ + ũ + u Example (p-bratu)

More information

Multilevel spectral coarse space methods in FreeFem++ on parallel architectures

Multilevel spectral coarse space methods in FreeFem++ on parallel architectures Multilevel spectral coarse space methods in FreeFem++ on parallel architectures Pierre Jolivet Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann DD 21, Rennes. June 29, 2012 In collaboration with

More information

On Some Variational Optimization Problems in Classical Fluids and Superfluids

On Some Variational Optimization Problems in Classical Fluids and Superfluids On Some Variational Optimization Problems in Classical Fluids and Superfluids Bartosz Protas Department of Mathematics & Statistics McMaster University, Hamilton, Ontario, Canada URL: http://www.math.mcmaster.ca/bprotas

More information

Multibody simulation

Multibody simulation Multibody simulation Dynamics of a multibody system (Newton-Euler formulation) Dimitar Dimitrov Örebro University June 8, 2012 Main points covered Newton-Euler formulation forward dynamics inverse dynamics

More information

Lecture 17: Iterative Methods and Sparse Linear Algebra

Lecture 17: Iterative Methods and Sparse Linear Algebra Lecture 17: Iterative Methods and Sparse Linear Algebra David Bindel 25 Mar 2014 Logistics HW 3 extended to Wednesday after break HW 4 should come out Monday after break Still need project description

More information

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Sunyoung Bu University of North Carolina Department of Mathematics CB # 325, Chapel Hill USA agatha@email.unc.edu Jingfang

More information

The Gross-Pitaevskii Equation and the Hydrodynamic Expansion of BECs

The Gross-Pitaevskii Equation and the Hydrodynamic Expansion of BECs The Gross-Pitaevskii Equation and the Hydrodynamic Expansion of BECs i ( ) t Φ (r, t) = 2 2 2m + V ext(r) + g Φ (r, t) 2 Φ (r, t) (Mewes et al., 1996) 26/11/2009 Stefano Carignano 1 Contents 1 Introduction

More information

arxiv: v1 [math.oc] 21 Jan 2019

arxiv: v1 [math.oc] 21 Jan 2019 An Efficient Parallel-in-Time Method for Optimization with Parabolic PDEs Sebastian Götschel Michael L. Minion arxiv:1901.06850v1 [math.oc] 21 Jan 2019 January 17, 2019 Abstract To solve optimization problems

More information

PAPER 84 QUANTUM FLUIDS

PAPER 84 QUANTUM FLUIDS MATHEMATICAL TRIPOS Part III Wednesday 6 June 2007 9.00 to 11.00 PAPER 84 QUANTUM FLUIDS Attempt TWO questions. There are FOUR questions in total. The questions carry equal weight. STATIONERY REQUIREMENTS

More information

Scientific Computing

Scientific Computing Lecture on Scientific Computing Dr. Kersten Schmidt Lecture 4 Technische Universität Berlin Institut für Mathematik Wintersemester 2014/2015 Syllabus Linear Regression Fast Fourier transform Modelling

More information

An Algorithmic Framework of Large-Scale Circuit Simulation Using Exponential Integrators

An Algorithmic Framework of Large-Scale Circuit Simulation Using Exponential Integrators An Algorithmic Framework of Large-Scale Circuit Simulation Using Exponential Integrators Hao Zhuang 1, Wenjian Yu 2, Ilgweon Kang 1, Xinan Wang 1, and Chung-Kuan Cheng 1 1. University of California, San

More information

Periodic motions. Periodic motions are known since the beginning of mankind: Motion of planets around the Sun; Pendulum; And many more...

Periodic motions. Periodic motions are known since the beginning of mankind: Motion of planets around the Sun; Pendulum; And many more... Periodic motions Periodic motions are known since the beginning of mankind: Motion of planets around the Sun; Pendulum; And many more... Periodic motions There are several quantities which describe a periodic

More information

Global Stability Analysis: Flow over a Backward-Facing Step

Global Stability Analysis: Flow over a Backward-Facing Step Global Stability Analysis: Flow over a Backward-Facing Step Tutorials November 25, 2017 Department of Aeronautics, Imperial College London, UK Scientific Computing and Imaging Institute, University of

More information

Guangye Chen, Luis Chacón,

Guangye Chen, Luis Chacón, JIFT workshop! Oct. 31, 2014 New Orleans, LA.! Guangye Chen, Luis Chacón, CoCoMANs team Los Alamos National Laboratory, Los Alamos, NM 87545, USA gchen@lanl.gov 1 Los Alamos National Laboratory Motivation

More information

Morse index of figure-eight choreography for equal mass three-body problem

Morse index of figure-eight choreography for equal mass three-body problem Morse index of figure-eight choreography for equal mass three-body problem Hiroshi Fukuda College of Liberal Arts and Sciences, Kitasato University (2017.3.22) In this talk We show Morse index of Figure-eight

More information

Numerical Methods in Matrix Computations

Numerical Methods in Matrix Computations Ake Bjorck Numerical Methods in Matrix Computations Springer Contents 1 Direct Methods for Linear Systems 1 1.1 Elements of Matrix Theory 1 1.1.1 Matrix Algebra 2 1.1.2 Vector Spaces 6 1.1.3 Submatrices

More information

Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media

Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media Raytcho Lazarov & Aziz Takhirov Texas A&M May 3-4, 2016 R. Lazarov & A.T. (Texas A&M) Brinkman May 3-4, 2016 1 / 30 Outline

More information

Preconditioned inverse iteration and shift-invert Arnoldi method

Preconditioned inverse iteration and shift-invert Arnoldi method Preconditioned inverse iteration and shift-invert Arnoldi method Melina Freitag Department of Mathematical Sciences University of Bath CSC Seminar Max-Planck-Institute for Dynamics of Complex Technical

More information

A Uniformly Convergent Numerical Method for Singularly Perturbed Nonlinear Eigenvalue Problems

A Uniformly Convergent Numerical Method for Singularly Perturbed Nonlinear Eigenvalue Problems COMMUNICATIONS IN COMPUTATIONAL PHYSICS Vol 4, No, pp 35-6 Commun Comput Phys July 8 A Uniformly Convergent Numerical Method for Singularly Perturbed Nonlinear Eigenvalue Problems Weizhu Bao, and Ming-Huang

More information

HPDDM une bibliothèque haute performance unifiée pour les méthodes de décomposition de domaine

HPDDM une bibliothèque haute performance unifiée pour les méthodes de décomposition de domaine HPDDM une bibliothèque haute performance unifiée pour les méthodes de décomposition de domaine P. Jolivet and Frédéric Nataf Laboratory J.L. Lions, Univ. Paris VI, Equipe Alpines INRIA-LJLL et CNRS joint

More information

Methods for Computing Periodic Steady-State Jacob White

Methods for Computing Periodic Steady-State Jacob White Introduction to Simulation - Lecture 15 Methods for Computing Periodic Steady-State Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Periodic Steady-state problems Application

More information

Fast Structured Spectral Methods

Fast Structured Spectral Methods Spectral methods HSS structures Fast algorithms Conclusion Fast Structured Spectral Methods Yingwei Wang Department of Mathematics, Purdue University Joint work with Prof Jie Shen and Prof Jianlin Xia

More information

Basic Aspects of Discretization

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

More information

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 1 SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 2 OUTLINE Sparse matrix storage format Basic factorization

More information

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for 1 Iteration basics Notes for 2016-11-07 An iterative solver for Ax = b is produces a sequence of approximations x (k) x. We always stop after finitely many steps, based on some convergence criterion, e.g.

More information

Course in. Geometric nonlinearity. Nonlinear FEM. Computational Mechanics, AAU, Esbjerg

Course in. Geometric nonlinearity. Nonlinear FEM. Computational Mechanics, AAU, Esbjerg Course in Nonlinear FEM Geometric nonlinearity Nonlinear FEM Outline Lecture 1 Introduction Lecture 2 Geometric nonlinearity Lecture 3 Material nonlinearity Lecture 4 Material nonlinearity it continued

More information

PROBABILITY: LIMIT THEOREMS II, SPRING HOMEWORK PROBLEMS

PROBABILITY: LIMIT THEOREMS II, SPRING HOMEWORK PROBLEMS PROBABILITY: LIMIT THEOREMS II, SPRING 15. HOMEWORK PROBLEMS PROF. YURI BAKHTIN Instructions. You are allowed to work on solutions in groups, but you are required to write up solutions on your own. Please

More information

Some notes about PDEs. -Bill Green Nov. 2015

Some notes about PDEs. -Bill Green Nov. 2015 Some notes about PDEs -Bill Green Nov. 2015 Partial differential equations (PDEs) are all BVPs, with the same issues about specifying boundary conditions etc. Because they are multi-dimensional, they can

More information

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Tengfei Su Applied Mathematics and Scientific Computing Advisor: Howard Elman Department of Computer Science Sept. 29, 2015 Tengfei

More information

Applied Mathematics 205. Unit V: Eigenvalue Problems. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit V: Eigenvalue Problems. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit V: Eigenvalue Problems Lecturer: Dr. David Knezevic Unit V: Eigenvalue Problems Chapter V.4: Krylov Subspace Methods 2 / 51 Krylov Subspace Methods In this chapter we give

More information

Laboratory Sessions : FreeFem + + CIMPA Workshop Navier Stokes Stabilization Code July 06 th July 17 th 2015 IIT Mumbai

Laboratory Sessions : FreeFem + + CIMPA Workshop Navier Stokes Stabilization Code July 06 th July 17 th 2015 IIT Mumbai Laboratory Sessions : FreeFem + + CIMPA Workshop Navier Stokes Stabilization Code July 06 th July 17 th 2015 IIT Mumbai IIT MUMBAI 400 076 Abstract This are a collection of comments on the code for Navier

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

Nested Krylov methods for shifted linear systems

Nested Krylov methods for shifted linear systems Nested Krylov methods for shifted linear systems M. Baumann, and M. B. van Gizen Email: M.M.Baumann@tudelft.nl Delft Institute of Applied Mathematics Delft University of Technology Delft, The Netherlands

More information

Efficient domain decomposition methods for the time-harmonic Maxwell equations

Efficient domain decomposition methods for the time-harmonic Maxwell equations Efficient domain decomposition methods for the time-harmonic Maxwell equations Marcella Bonazzoli 1, Victorita Dolean 2, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier 4 1 Inria Saclay (Defi

More information

Computational Methods CMSC/AMSC/MAPL 460

Computational Methods CMSC/AMSC/MAPL 460 Computational Methods CMSC/AMSC/MAPL 460 Fourier transform Balaji Vasan Srinivasan Dept of Computer Science Several slides from Prof Healy s course at UMD Last time: Fourier analysis F(t) = A 0 /2 + A

More information

Iterative Solvers in the Finite Element Solution of Transient Heat Conduction

Iterative Solvers in the Finite Element Solution of Transient Heat Conduction Iterative Solvers in the Finite Element Solution of Transient Heat Conduction Mile R. Vuji~i} PhD student Steve G.R. Brown Senior Lecturer Materials Research Centre School of Engineering University of

More information

Fast Iterative Solution of Saddle Point Problems

Fast Iterative Solution of Saddle Point Problems Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, GA Acknowledgments NSF (Computational Mathematics) Maxim Olshanskii (Mech-Math, Moscow State U.) Zhen Wang (PhD student,

More information

Sparse Matrix Computations in Arterial Fluid Mechanics

Sparse Matrix Computations in Arterial Fluid Mechanics Sparse Matrix Computations in Arterial Fluid Mechanics Murat Manguoğlu Middle East Technical University, Turkey Kenji Takizawa Ahmed Sameh Tayfun Tezduyar Waseda University, Japan Purdue University, USA

More information