Estimation of State Noise for the Ensemble Kalman filter algorithm for 2D shallow water equations.

Size: px
Start display at page:

Download "Estimation of State Noise for the Ensemble Kalman filter algorithm for 2D shallow water equations."

Transcription

1 Estimation of State Noise for the Ensemble Kalman filter algorithm for 2D shallow water equations. May 6, 2009

2 Motivation Constitutive Equations EnKF algorithm Some results Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Validation method Future work

3 Motivation Motivation Constitutive Equations EnKF algorithm Some results Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Validation method Future work

4 Sacramento Delta Motivation

5 Sacramento Delta Motivation Before the levee breach

6 Sacramento Delta Motivation After the levee breach

7 Lagrangian sensors Motivation Lagrangian sensors measure their positions as they drift along with the flow. When trying to solve the two-dimensional shallow water equations, one needs accurate initial and boundary conditions which are usually not available. Data assimilation of the Lagrangian measurements from the drifters allow to estimate the velocity field in the river even without accurate boundary conditions.

8 Constitutive Equations EnKF algorithm Some results Motivation Constitutive Equations EnKF algorithm Some results Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Validation method Future work

9 Constitutive Equations EnKF algorithm Some results Two-dimensional shallow water equations u t + U u = g η x + F x + 1 h (hν t u) (1) v t + U v = g η y + F y + 1 h (hν t v) (2) h t + U h + h u = 0 (3) h: total water depth U = (u, v): velocity field where F x = 1 F y = 1 gn 2 cos α gn 2 cos α h 4/3 u u 2 + v 2 h 4/3 v u 2 + v 2 η: free surface elevation ν t: turbulent diffusion coefficient α = α(x, y): bottom slope n: Manning coefficient.

10 Constitutive Equations EnKF algorithm Some results Two-dimensional shallow water equations Boundary conditions: u(x, y, t) Ωland = 0, v(x, y, t) Ωland = 0, (4) (u(x, y, t), v(x, y, t)) Ωupstream = f (x, y, t), (5) η(x, y, t) Ωdownstream = g(x, y, t), (6) Initial conditions: u(x, y, 0) = u 0, v(x, y, 0) = v 0, h(x, y, 0) = h 0, (7)

11 Drifter model Constitutive Equations EnKF algorithm Some results dx Di (t) dt dy Di (t) dt = u(x Di (t), y Di (t), t), (8) = v(x Di (t), y Di (t), t), (9)

12 State Augmentation Constitutive Equations EnKF algorithm Some results We use state augmentation to simplify the observation model u(t n ) v(t n ) h(t n ) θ n = x D (t n ) y D (t n ) (10)

13 Forward model Constitutive Equations EnKF algorithm Some results θ n+1 = F n (θ n ) + w n. (11) F n : one time step in the discretized shallow water and drifter model. θ n+1 : predicted system state at time t n+1. w n : state noise (modeling error between the reality and the 2D model). Q n : covariance of the state noise.

14 Observation model Constitutive Equations EnKF algorithm Some results y n : measurements from the drifters. C n = (0 I): observation model. ɛ n : measurement noise. R n : covariance of the measurement noise. y n = C n θ n + ɛ n. (12)

15 EnKF Algorithm Constitutive Equations EnKF algorithm Some results 1. Initialization: An ensemble of N states states ξ (p) 0 indexed by p are generated to represent the uncertainty in θ Time update: ξ (p) n n 1 = Fn(ξ(p) n 1 n 1 ) + w (p) n 1 (13) θ n n 1 = 1 N states ξ (p) (14) N n n 1 states p=1 E n n 1 = [ξ (1) n n 1 θ n n 1,..., ξ (Nstates) n n 1 θ n n 1 ] (15)

16 EnKF Algorithm Constitutive Equations EnKF algorithm Some results 3. Measurement update: 1 Γ n n 1 = N states 1 E n n 1En n 1 T (16) K n = Γ n n 1 Cn T (C n Γ n n 1 Cn T + R n ) 1 (17) ξ (p) n n = ξ(i) n n 1 + K n(y n C n ξ (p) n n 1 + ɛ(p) n ) (18)

17 Twin experiment results Constitutive Equations EnKF algorithm Some results Drifters are released using a software and the EnKF algorithm runs using those measurements.

18 Limitations Constitutive Equations EnKF algorithm Some results The state noise used here is realistic for twin experiments, since we know the discrepancy between the reality and the model, as they are both from the same software. We need more realistic state noise in order to have the algorithm run with the real data from November experiment.

19 Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Motivation Constitutive Equations EnKF algorithm Some results Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Validation method Future work

20 Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Eulerian sensors - Boundary Conditions Mike 3 θ n Interpolation Mike 3 TELEMAC 2D θ n+1 F (θ n) State noise estimation w n = θ n+1 F (θ n) Statistical study Covariance of the state noise Q n

21 Navier-Stokes equations Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences 1 ρc 2 s P t + u j x j = SS (19) u i t + (u iu j ) x j + 2Ω ij u j = 1 P + g i ρ x i + x j (ν T { u i x i + u j x j } 2 3 δ ijk) + u i SS (20)

22 Testing the hydrostatic assumption Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Hydrostatic assumption: pressure in the river can be estimated using the hydrostatic pressure. Valid for L H >> 1, where L is the horizontal characteristic length of the river.

23 Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Navier-Stokes equations using hydrostatic assumption u t + u2 x + vu y + wu z 1 ρ 0 h ( sxx x + s xy y v t + uv x + v 2 y + wv z 1 ρ 0 h ( syx x + s xy y u x + v y + w z = 0 (21) η = g ) + F u + z η = g ) + F v + z x 1 p a ρ 0 x g ρ ( ) 0 u ν t z y 1 p a ρ 0 y g ρ ( ) 0 v ν t z η z η z ρ x dz ρ y dz (22) (23)

24 Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Telemac2D Mike 3 Vertical Eddy Viscosity ν t Eddy viscosity ν t Horizontal Eddy Viscosity A Manning s n Roughness height k s Figure: Equivalence of parameters between the two dimensional and the three dimensional models. A relationship between the roughness height and the Manning s n can be found as: n = k 1 6 s 25.4 (24)

25 Three dimensional simulations Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences

26 Boundary conditions Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences

27 Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences

28 Result of the 3D simulation Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences

29 State noise characteristics Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences

30 Validation method Future work Motivation Constitutive Equations EnKF algorithm Some results Method Navier Stokes equations and assumptions Parameter adjustments Generation of state noise occurrences Validation method Future work

31 Real data Validation method Future work

32 Validation method Future work Cross validation principle No data are available to validate. Remove 1 or 2 drifters from the data set. Run the EnKF on the remaining drifters. Compute the trajectory of the extracted drifters using the estimated velocity field. Compare it with the real trajectory.

33 Validation method Future work Future work Run the EnKF using the real data set and the generated state noise. Generate a state noise model for the drifters.

34 Validation method Future work Questions?

Methods of Data Assimilation and Comparisons for Lagrangian Data

Methods of Data Assimilation and Comparisons for Lagrangian Data Methods of Data Assimilation and Comparisons for Lagrangian Data Chris Jones, Warwick and UNC-CH Kayo Ide, UCLA Andrew Stuart, Jochen Voss, Warwick Guillaume Vernieres, UNC-CH Amarjit Budiraja, UNC-CH

More information

Lagrangian Data Assimilation and Its Application to Geophysical Fluid Flows

Lagrangian Data Assimilation and Its Application to Geophysical Fluid Flows Lagrangian Data Assimilation and Its Application to Geophysical Fluid Flows Laura Slivinski June, 3 Laura Slivinski (Brown University) Lagrangian Data Assimilation June, 3 / 3 Data Assimilation Setup:

More information

Adaptive ensemble Kalman filtering of nonlinear systems

Adaptive ensemble Kalman filtering of nonlinear systems Adaptive ensemble Kalman filtering of nonlinear systems Tyrus Berry George Mason University June 12, 213 : Problem Setup We consider a system of the form: x k+1 = f (x k ) + ω k+1 ω N (, Q) y k+1 = h(x

More information

The semi-geostrophic equations - a model for large-scale atmospheric flows

The semi-geostrophic equations - a model for large-scale atmospheric flows The semi-geostrophic equations - a model for large-scale atmospheric flows Beatrice Pelloni, University of Reading with M. Cullen (Met Office), D. Gilbert, T. Kuna INI - MFE Dec 2013 Introduction - Motivation

More information

Global well-posedness of the primitive equations of oceanic and atmospheric dynamics

Global well-posedness of the primitive equations of oceanic and atmospheric dynamics Global well-posedness of the primitive equations of oceanic and atmospheric dynamics Jinkai Li Department of Mathematics The Chinese University of Hong Kong Dynamics of Small Scales in Fluids ICERM, Feb

More information

Short tutorial on data assimilation

Short tutorial on data assimilation Mitglied der Helmholtz-Gemeinschaft Short tutorial on data assimilation 23 June 2015 Wolfgang Kurtz & Harrie-Jan Hendricks Franssen Institute of Bio- and Geosciences IBG-3 (Agrosphere), Forschungszentrum

More information

Lecture: Wave-induced Momentum Fluxes: Radiation Stresses

Lecture: Wave-induced Momentum Fluxes: Radiation Stresses Chapter 4 Lecture: Wave-induced Momentum Fluxes: Radiation Stresses Here we derive the wave-induced depth-integrated momentum fluxes, otherwise known as the radiation stress tensor S. These are the 2nd-order

More information

A Simple Turbulence Closure Model

A Simple Turbulence Closure Model A Simple Turbulence Closure Model Atmospheric Sciences 6150 1 Cartesian Tensor Notation Reynolds decomposition of velocity: Mean velocity: Turbulent velocity: Gradient operator: Advection operator: V =

More information

State estimation and modeling error approach for 2D shallow water equations and Lagrangian measurements

State estimation and modeling error approach for 2D shallow water equations and Lagrangian measurements WATER RESOURCES RESEARCH, VOL.???, XXXX, DOI:10.1029/, 1 2 3 State estimation and modeling error approach for 2D shallow water equations and Lagrangian measurements O.-P. Tossavainen 1,3, J. Percelay 1,

More information

. p.1/31. Department Mathematics and Statistics Arizona State University. Don Jones

. p.1/31. Department Mathematics and Statistics Arizona State University. Don Jones Modified-Truncation Finite Difference Schemes. p.1/31 Department Mathematics and Statistics Arizona State University Don Jones dajones@math.asu.edu . p.2/31 Heat Equation t u = λu xx + f . p.2/31 Heat

More information

Getting started: CFD notation

Getting started: CFD notation PDE of p-th order Getting started: CFD notation f ( u,x, t, u x 1,..., u x n, u, 2 u x 1 x 2,..., p u p ) = 0 scalar unknowns u = u(x, t), x R n, t R, n = 1,2,3 vector unknowns v = v(x, t), v R m, m =

More information

Lagrangian data assimilation for point vortex systems

Lagrangian data assimilation for point vortex systems JOT J OURNAL OF TURBULENCE http://jot.iop.org/ Lagrangian data assimilation for point vortex systems Kayo Ide 1, Leonid Kuznetsov 2 and Christopher KRTJones 2 1 Department of Atmospheric Sciences and Institute

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Enhancing information transfer from observations to unobserved state variables for mesoscale radar data assimilation

Enhancing information transfer from observations to unobserved state variables for mesoscale radar data assimilation Enhancing information transfer from observations to unobserved state variables for mesoscale radar data assimilation Weiguang Chang and Isztar Zawadzki Department of Atmospheric and Oceanic Sciences Faculty

More information

Lagrangian Data Assimilation and Manifold Detection for a Point-Vortex Model. David Darmon, AMSC Kayo Ide, AOSC, IPST, CSCAMM, ESSIC

Lagrangian Data Assimilation and Manifold Detection for a Point-Vortex Model. David Darmon, AMSC Kayo Ide, AOSC, IPST, CSCAMM, ESSIC Lagrangian Data Assimilation and Manifold Detection for a Point-Vortex Model David Darmon, AMSC Kayo Ide, AOSC, IPST, CSCAMM, ESSIC Background Data Assimilation Iterative process Forecast Analysis Background

More information

Parameter Estimation in Reservoir Engineering Models via Data Assimilation Techniques

Parameter Estimation in Reservoir Engineering Models via Data Assimilation Techniques Parameter Estimation in Reservoir Engineering Models via Data Assimilation Techniques Mariya V. Krymskaya TU Delft July 6, 2007 Ensemble Kalman Filter (EnKF) Iterative Ensemble Kalman Filter (IEnKF) State

More information

Linear-Quadratic-Gaussian (LQG) Controllers and Kalman Filters

Linear-Quadratic-Gaussian (LQG) Controllers and Kalman Filters Linear-Quadratic-Gaussian (LQG) Controllers and Kalman Filters Emo Todorov Applied Mathematics and Computer Science & Engineering University of Washington Winter 204 Emo Todorov (UW) AMATH/CSE 579, Winter

More information

Stochastic Collocation Methods for Polynomial Chaos: Analysis and Applications

Stochastic Collocation Methods for Polynomial Chaos: Analysis and Applications Stochastic Collocation Methods for Polynomial Chaos: Analysis and Applications Dongbin Xiu Department of Mathematics, Purdue University Support: AFOSR FA955-8-1-353 (Computational Math) SF CAREER DMS-64535

More information

UNIVERSITY OF OKLAHOMA GRADUATE COLLEGE APPLICATION OF THE FORWARD SENSITIVITY METHOD TO DATA ASSIMILATION OF THE LAGRANGIAN TRACER DYNAMICS

UNIVERSITY OF OKLAHOMA GRADUATE COLLEGE APPLICATION OF THE FORWARD SENSITIVITY METHOD TO DATA ASSIMILATION OF THE LAGRANGIAN TRACER DYNAMICS UNIVERSITY OF OKLAHOMA GRADUATE COLLEGE APPLICATION OF THE FORWARD SENSITIVITY METHOD TO DATA ASSIMILATION OF THE LAGRANGIAN TRACER DYNAMICS A DISSERTATION SUBMITTED TO THE GRADUATE FACULTY in partial

More information

Modelling Interactions Between Weather and Climate

Modelling Interactions Between Weather and Climate Modelling Interactions Between Weather and Climate p. 1/33 Modelling Interactions Between Weather and Climate Adam Monahan & Joel Culina monahana@uvic.ca & culinaj@uvic.ca School of Earth and Ocean Sciences,

More information

Stability of Ensemble Kalman Filters

Stability of Ensemble Kalman Filters Stability of Ensemble Kalman Filters Idrissa S. Amour, Zubeda Mussa, Alexander Bibov, Antti Solonen, John Bardsley, Heikki Haario and Tuomo Kauranne Lappeenranta University of Technology University of

More information

Direct and Large Eddy Simulation of stably stratified turbulent Ekman layers

Direct and Large Eddy Simulation of stably stratified turbulent Ekman layers Direct and Large Eddy Simulation of stably stratified turbulent Ekman layers Stimit Shah, Elie Bou-Zeid Princeton University 64 th APS DFD Baltimore, Maryland Nov 21, 211 Effect of Stability on Atmospheric

More information

Introduction to Turbulence and Turbulence Modeling

Introduction to Turbulence and Turbulence Modeling Introduction to Turbulence and Turbulence Modeling Part I Venkat Raman The University of Texas at Austin Lecture notes based on the book Turbulent Flows by S. B. Pope Turbulent Flows Turbulent flows Commonly

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

From Navier-Stokes to Saint-Venant

From Navier-Stokes to Saint-Venant From Navier-Stokes to Saint-Venant Course 1 E. Godlewski 1 & J. Sainte-Marie 1 1 ANGE team LJLL - January 2017 Euler Eulerian vs. Lagrangian description Lagrange x(t M(t = y(t, z(t flow of the trajectories

More information

A Simple Turbulence Closure Model. Atmospheric Sciences 6150

A Simple Turbulence Closure Model. Atmospheric Sciences 6150 A Simple Turbulence Closure Model Atmospheric Sciences 6150 1 Cartesian Tensor Notation Reynolds decomposition of velocity: V = V + v V = U i + u i Mean velocity: V = Ui + V j + W k =(U, V, W ) U i =(U

More information

Candidates must show on each answer book the type of calculator used. Log Tables, Statistical Tables and Graph Paper are available on request.

Candidates must show on each answer book the type of calculator used. Log Tables, Statistical Tables and Graph Paper are available on request. UNIVERSITY OF EAST ANGLIA School of Mathematics Spring Semester Examination 2004 FLUID DYNAMICS Time allowed: 3 hours Attempt Question 1 and FOUR other questions. Candidates must show on each answer book

More information

Homogenization with stochastic differential equations

Homogenization with stochastic differential equations Homogenization with stochastic differential equations Scott Hottovy shottovy@math.arizona.edu University of Arizona Program in Applied Mathematics October 12, 2011 Modeling with SDE Use SDE to model system

More information

What do we know about EnKF?

What do we know about EnKF? What do we know about EnKF? David Kelly Kody Law Andrew Stuart Andrew Majda Xin Tong Courant Institute New York University New York, NY April 10, 2015 CAOS seminar, Courant. David Kelly (NYU) EnKF April

More information

UNIVERSITY OF EAST ANGLIA

UNIVERSITY OF EAST ANGLIA UNIVERSITY OF EAST ANGLIA School of Mathematics May/June UG Examination 2007 2008 FLUIDS DYNAMICS WITH ADVANCED TOPICS Time allowed: 3 hours Attempt question ONE and FOUR other questions. Candidates must

More information

Inverse Modeling for Open Boundary Conditions in Channel Network

Inverse Modeling for Open Boundary Conditions in Channel Network Joint 48th IEEE Conference on Decision and Control and 28th Chinese Control Conference Shanghai, P.R. China, December 16-18, 29 Inverse Modeling for Open Boundary Conditions in Channel Network Qingfang

More information

Conveyance Estimation System (CES) Launch

Conveyance Estimation System (CES) Launch (CES) Launch Conveyance Principles Caroline McGahey 10 June 2004 Why is there a new approach? Existing 1D software still based on historic hand-calculation methods - not based in rigorous physics - as

More information

UNIVERSITY of LIMERICK

UNIVERSITY of LIMERICK UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH Faculty of Science and Engineering END OF SEMESTER ASSESSMENT PAPER MODULE CODE: MA4607 SEMESTER: Autumn 2012-13 MODULE TITLE: Introduction to Fluids DURATION OF

More information

Filtering the Navier-Stokes Equation

Filtering the Navier-Stokes Equation Filtering the Navier-Stokes Equation Andrew M Stuart1 1 Mathematics Institute and Centre for Scientific Computing University of Warwick Geometric Methods Brown, November 4th 11 Collaboration with C. Brett,

More information

A scaling limit from Euler to Navier-Stokes equations with random perturbation

A scaling limit from Euler to Navier-Stokes equations with random perturbation A scaling limit from Euler to Navier-Stokes equations with random perturbation Franco Flandoli, Scuola Normale Superiore of Pisa Newton Institute, October 208 Newton Institute, October 208 / Subject of

More information

The 2D Magnetohydrodynamic Equations with Partial Dissipation. Oklahoma State University

The 2D Magnetohydrodynamic Equations with Partial Dissipation. Oklahoma State University The 2D Magnetohydrodynamic Equations with Partial Dissipation Jiahong Wu Oklahoma State University IPAM Workshop Mathematical Analysis of Turbulence IPAM, UCLA, September 29-October 3, 2014 1 / 112 Outline

More information

/01/04: Morrison s Equation SPRING 2004 A. H. TECHET

/01/04: Morrison s Equation SPRING 2004 A. H. TECHET 3.4 04/0/04: orrison s Equation SPRING 004 A.. TECET. General form of orrison s Equation Flow past a circular cylinder is a canonical problem in ocean engineering. For a purely inviscid, steady flow we

More information

Data assimilation with and without a model

Data assimilation with and without a model Data assimilation with and without a model Tyrus Berry George Mason University NJIT Feb. 28, 2017 Postdoc supported by NSF This work is in collaboration with: Tim Sauer, GMU Franz Hamilton, Postdoc, NCSU

More information

Hydrodynamics for Ocean Engineers Prof. A.H. Techet Fall 2004

Hydrodynamics for Ocean Engineers Prof. A.H. Techet Fall 2004 13.01 ydrodynamics for Ocean Engineers Prof. A.. Techet Fall 004 Morrison s Equation 1. General form of Morrison s Equation Flow past a circular cylinder is a canonical problem in ocean engineering. For

More information

A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems

A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems Bob Peeters Joint work with Onno Bokhove & Jason Frank TW, University of Twente, Enschede CWI, Amsterdam PhD-TW colloquium, 9th

More information

arxiv:physics/ v2 [physics.flu-dyn] 3 Jul 2007

arxiv:physics/ v2 [physics.flu-dyn] 3 Jul 2007 Leray-α model and transition to turbulence in rough-wall boundary layers Alexey Cheskidov Department of Mathematics, University of Michigan, Ann Arbor, Michigan 4819 arxiv:physics/6111v2 [physics.flu-dyn]

More information

A Note on the Particle Filter with Posterior Gaussian Resampling

A Note on the Particle Filter with Posterior Gaussian Resampling Tellus (6), 8A, 46 46 Copyright C Blackwell Munksgaard, 6 Printed in Singapore. All rights reserved TELLUS A Note on the Particle Filter with Posterior Gaussian Resampling By X. XIONG 1,I.M.NAVON 1,2 and

More information

On variational data assimilation for 1D and 2D fluvial hydraulics

On variational data assimilation for 1D and 2D fluvial hydraulics On variational data assimilation for D and D fluvial hydraulics I. Gejadze, M. Honnorat, FX Le Dimet, and J. Monnier LJK - MOISE project-team, Grenoble, France. Contact: Jerome.Monnier@imag.fr Civil Engineering

More information

Fluid Dynamics Exercises and questions for the course

Fluid Dynamics Exercises and questions for the course Fluid Dynamics Exercises and questions for the course January 15, 2014 A two dimensional flow field characterised by the following velocity components in polar coordinates is called a free vortex: u r

More information

Correcting biased observation model error in data assimilation

Correcting biased observation model error in data assimilation Correcting biased observation model error in data assimilation Tyrus Berry Dept. of Mathematical Sciences, GMU PSU-UMD DA Workshop June 27, 217 Joint work with John Harlim, PSU BIAS IN OBSERVATION MODELS

More information

Ergodicity in data assimilation methods

Ergodicity in data assimilation methods Ergodicity in data assimilation methods David Kelly Andy Majda Xin Tong Courant Institute New York University New York NY www.dtbkelly.com April 15, 2016 ETH Zurich David Kelly (CIMS) Data assimilation

More information

Exercise 5: Exact Solutions to the Navier-Stokes Equations I

Exercise 5: Exact Solutions to the Navier-Stokes Equations I Fluid Mechanics, SG4, HT009 September 5, 009 Exercise 5: Exact Solutions to the Navier-Stokes Equations I Example : Plane Couette Flow Consider the flow of a viscous Newtonian fluid between two parallel

More information

Lecture 1: Introduction to Linear and Non-Linear Waves

Lecture 1: Introduction to Linear and Non-Linear Waves Lecture 1: Introduction to Linear and Non-Linear Waves Lecturer: Harvey Segur. Write-up: Michael Bates June 15, 2009 1 Introduction to Water Waves 1.1 Motivation and Basic Properties There are many types

More information

Integrodifferential Hyperbolic Equations and its Application for 2-D Rotational Fluid Flows

Integrodifferential Hyperbolic Equations and its Application for 2-D Rotational Fluid Flows Integrodifferential Hyperbolic Equations and its Application for 2-D Rotational Fluid Flows Alexander Chesnokov Lavrentyev Institute of Hydrodynamics Novosibirsk, Russia chesnokov@hydro.nsc.ru July 14,

More information

NONLOCAL DIFFUSION EQUATIONS

NONLOCAL DIFFUSION EQUATIONS NONLOCAL DIFFUSION EQUATIONS JULIO D. ROSSI (ALICANTE, SPAIN AND BUENOS AIRES, ARGENTINA) jrossi@dm.uba.ar http://mate.dm.uba.ar/ jrossi 2011 Non-local diffusion. The function J. Let J : R N R, nonnegative,

More information

MULTISCALE ANALYSIS IN LAGRANGIAN FORMULATION FOR THE 2-D INCOMPRESSIBLE EULER EQUATION. Thomas Y. Hou. Danping Yang. Hongyu Ran

MULTISCALE ANALYSIS IN LAGRANGIAN FORMULATION FOR THE 2-D INCOMPRESSIBLE EULER EQUATION. Thomas Y. Hou. Danping Yang. Hongyu Ran DISCRETE AND CONTINUOUS Website: http://aimsciences.org DYNAMICAL SYSTEMS Volume 13, Number 5, December 2005 pp. 1153 1186 MULTISCALE ANALYSIS IN LAGRANGIAN FORMULATION FOR THE 2-D INCOMPRESSIBLE EULER

More information

Computational Fluid Dynamics 2

Computational Fluid Dynamics 2 Seite 1 Introduction Computational Fluid Dynamics 11.07.2016 Computational Fluid Dynamics 2 Turbulence effects and Particle transport Martin Pietsch Computational Biomechanics Summer Term 2016 Seite 2

More information

Smoothers: Types and Benchmarks

Smoothers: Types and Benchmarks Smoothers: Types and Benchmarks Patrick N. Raanes Oxford University, NERSC 8th International EnKF Workshop May 27, 2013 Chris Farmer, Irene Moroz Laurent Bertino NERSC Geir Evensen Abstract Talk builds

More information

Sediment transport and river bed evolution

Sediment transport and river bed evolution 1 Chapter 1 Sediment transport and river bed evolution 1.1 What is the sediment transport? What is the river bed evolution? System of the interaction between flow and river beds Rivers transport a variety

More information

EnKF-based particle filters

EnKF-based particle filters EnKF-based particle filters Jana de Wiljes, Sebastian Reich, Wilhelm Stannat, Walter Acevedo June 20, 2017 Filtering Problem Signal dx t = f (X t )dt + 2CdW t Observations dy t = h(x t )dt + R 1/2 dv t.

More information

Instructor: Sudipta Mukherji, Institute of Physics, Bhubaneswar

Instructor: Sudipta Mukherji, Institute of Physics, Bhubaneswar Chapter 1 Lorentz and Poincare Instructor: Sudipta Mukherji, Institute of Physics, Bhubaneswar 1.1 Lorentz Transformation Consider two inertial frames S and S, where S moves with a velocity v with respect

More information

Densities for the Navier Stokes equations with noise

Densities for the Navier Stokes equations with noise Densities for the Navier Stokes equations with noise Marco Romito Università di Pisa Universitat de Barcelona March 25, 2015 Summary 1 Introduction & motivations 2 Malliavin calculus 3 Besov bounds 4 Other

More information

( ) II. Why statistics? SIO 221B, Rudnick adapted from Davis!1

( ) II. Why statistics? SIO 221B, Rudnick adapted from Davis!1 SIO 221B, Rudnick adapted from Davis 1 II. Why statistics? This course addresses the analysis of oceanographic observations and, as they become more complex, ocean models. Much of the material involves

More information

Robot Localization and Kalman Filters

Robot Localization and Kalman Filters Robot Localization and Kalman Filters Rudy Negenborn rudy@negenborn.net August 26, 2003 Outline Robot Localization Probabilistic Localization Kalman Filters Kalman Localization Kalman Localization with

More information

Nonlinear error dynamics for cycled data assimilation methods

Nonlinear error dynamics for cycled data assimilation methods Nonlinear error dynamics for cycled data assimilation methods A J F Moodey 1, A S Lawless 1,2, P J van Leeuwen 2, R W E Potthast 1,3 1 Department of Mathematics and Statistics, University of Reading, UK.

More information

Vorticity and Dynamics

Vorticity and Dynamics Vorticity and Dynamics In Navier-Stokes equation Nonlinear term ω u the Lamb vector is related to the nonlinear term u 2 (u ) u = + ω u 2 Sort of Coriolis force in a rotation frame Viscous term ν u = ν

More information

EnKF and filter divergence

EnKF and filter divergence EnKF and filter divergence David Kelly Andrew Stuart Kody Law Courant Institute New York University New York, NY dtbkelly.com December 12, 2014 Applied and computational mathematics seminar, NIST. David

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

A Spectral Approach to Linear Bayesian Updating

A Spectral Approach to Linear Bayesian Updating A Spectral Approach to Linear Bayesian Updating Oliver Pajonk 1,2, Bojana V. Rosic 1, Alexander Litvinenko 1, and Hermann G. Matthies 1 1 Institute of Scientific Computing, TU Braunschweig, Germany 2 SPT

More information

Alexei F. Cheviakov. University of Saskatchewan, Saskatoon, Canada. INPL seminar June 09, 2011

Alexei F. Cheviakov. University of Saskatchewan, Saskatoon, Canada. INPL seminar June 09, 2011 Direct Method of Construction of Conservation Laws for Nonlinear Differential Equations, its Relation with Noether s Theorem, Applications, and Symbolic Software Alexei F. Cheviakov University of Saskatchewan,

More information

Demonstration and Comparison of of Sequential Approaches for Altimeter Data Assimilation in in HYCOM

Demonstration and Comparison of of Sequential Approaches for Altimeter Data Assimilation in in HYCOM Demonstration and Comparison of of Sequential Approaches for Altimeter Data Assimilation in in HYCOM A. Srinivasan, E. P. Chassignet, O. M. Smedstad, C. Thacker, L. Bertino, P. Brasseur, T. M. Chin,, F.

More information

Data assimilation with and without a model

Data assimilation with and without a model Data assimilation with and without a model Tim Sauer George Mason University Parameter estimation and UQ U. Pittsburgh Mar. 5, 2017 Partially supported by NSF Most of this work is due to: Tyrus Berry,

More information

A simple model of topographic Rossby waves in the ocean

A simple model of topographic Rossby waves in the ocean A simple model of topographic Rossby waves in the ocean V.Teeluck, S.D.Griffiths, C.A.Jones University of Leeds April 18, 2013 V.Teeluck (University of Leeds) Topographic Rossby waves (TRW) in the ocean

More information

MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies

MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies 13th February 2015 Jorge Lindley email: J.V.M.Lindley@warwick.ac.uk 1 2D Flows - Shear flows Example 1. Flow over an inclined plane A

More information

Improving Inundation Forecasting using Data Assimilation

Improving Inundation Forecasting using Data Assimilation Improving Inundation Forecasting using Data Assimilation E.S. Cooper 1, S.L. Dance 1,2, N.K. Nichols 1,2, P.J. Smith 2, J. Garcia-Pintado 1 1 Department of Meteorology 2 Department of Mathematics and Statistics

More information

Estimation of River Current Using Kalman Filter Finite Element Method. Abstract

Estimation of River Current Using Kalman Filter Finite Element Method. Abstract Kawahara Lab (February, ) Chuo Univ. JAPAN Estimation of River Current Using Kalman Filter Finite Element Method Shin-ichiro SEKIGUCHI Department of Civil Engineering, Chuo University, Kasuga --7, Bunkyo-ku,

More information

Physical Oceanography, MSCI 3001 Oceanographic Processes, MSCI Dr. Katrin Meissner Week 5.

Physical Oceanography, MSCI 3001 Oceanographic Processes, MSCI Dr. Katrin Meissner Week 5. Physical Oceanography, MSCI 3001 Oceanographic Processes, MSCI 5004 Dr. Katrin Meissner k.meissner@unsw.e.au Week 5 Ocean Dynamics Transport of Volume, Heat & Salt Flux: Amount of heat, salt or volume

More information

Automatic Eddy Viscosity Assignment for 2-D Hydrodynamic Model of Szczecin Bay

Automatic Eddy Viscosity Assignment for 2-D Hydrodynamic Model of Szczecin Bay PUBLS. INST. GEOPHYS. POL. ACAD. SC., E-6 (390), 006 Automatic Eddy Viscosity Assignment for -D Hydrodynamic Model of Szczecin Bay Ryszard EWERTOWSKI 1, 1 Technical University of Szczecin, Building and

More information

Math 1501 Calc I Summer 2015 QUP SOUP w/ GTcourses

Math 1501 Calc I Summer 2015 QUP SOUP w/ GTcourses Math 1501 Calc I Summer 2015 QUP SOUP w/ GTcourses Instructor: Sal Barone School of Mathematics Georgia Tech May 22, 2015 (updated May 22, 2015) Covered sections: 3.3 & 3.5 Exam 1 (Ch.1 - Ch.3) Thursday,

More information

Horizontal buoyancy-driven flow along a differentially cooled underlying surface

Horizontal buoyancy-driven flow along a differentially cooled underlying surface Horizontal buoyancy-driven flow along a differentially cooled underlying surface By Alan Shapiro and Evgeni Fedorovich School of Meteorology, University of Oklahoma, Norman, OK, USA 6th Baltic Heat Transfer

More information

Turbulent drag reduction by streamwise traveling waves

Turbulent drag reduction by streamwise traveling waves 51st IEEE Conference on Decision and Control December 10-13, 2012. Maui, Hawaii, USA Turbulent drag reduction by streamwise traveling waves Armin Zare, Binh K. Lieu, and Mihailo R. Jovanović Abstract For

More information

Lecture 2: From Linear Regression to Kalman Filter and Beyond

Lecture 2: From Linear Regression to Kalman Filter and Beyond Lecture 2: From Linear Regression to Kalman Filter and Beyond Department of Biomedical Engineering and Computational Science Aalto University January 26, 2012 Contents 1 Batch and Recursive Estimation

More information

Boundary conditions and estimates for the linearized Navier-Stokes equations on staggered grids

Boundary conditions and estimates for the linearized Navier-Stokes equations on staggered grids Boundary conditions and estimates for the linearized Navier-Stokes equations on staggered grids Wendy Kress and Jonas Nilsson Department of Scientific Computing Uppsala University Box S-75 4 Uppsala Sweden

More information

AP Calculus 2004 AB FRQ Solutions

AP Calculus 2004 AB FRQ Solutions AP Calculus 4 AB FRQ Solutions Louis A. Talman, Ph. D. Emeritus Professor of Mathematics Metropolitan State University of Denver July, 7 Problem. Part a The function F (t) = 8 + 4 sin(t/) gives the rate,

More information

Information geometry for bivariate distribution control

Information geometry for bivariate distribution control Information geometry for bivariate distribution control C.T.J.Dodson + Hong Wang Mathematics + Control Systems Centre, University of Manchester Institute of Science and Technology Optimal control of stochastic

More information

A data-driven method for improving the correlation estimation in serial ensemble Kalman filter

A data-driven method for improving the correlation estimation in serial ensemble Kalman filter A data-driven method for improving the correlation estimation in serial ensemble Kalman filter Michèle De La Chevrotière, 1 John Harlim 2 1 Department of Mathematics, Penn State University, 2 Department

More information

1 Kalman Filter Introduction

1 Kalman Filter Introduction 1 Kalman Filter Introduction You should first read Chapter 1 of Stochastic models, estimation, and control: Volume 1 by Peter S. Maybec (available here). 1.1 Explanation of Equations (1-3) and (1-4) Equation

More information

Green s Functions and Distributions

Green s Functions and Distributions CHAPTER 9 Green s Functions and Distributions 9.1. Boundary Value Problems We would like to study, and solve if possible, boundary value problems such as the following: (1.1) u = f in U u = g on U, where

More information

IMPACTS OF SIGMA COORDINATES ON THE EULER AND NAVIER-STOKES EQUATIONS USING CONTINUOUS/DISCONTINUOUS GALERKIN METHODS

IMPACTS OF SIGMA COORDINATES ON THE EULER AND NAVIER-STOKES EQUATIONS USING CONTINUOUS/DISCONTINUOUS GALERKIN METHODS Approved for public release; distribution is unlimited IMPACTS OF SIGMA COORDINATES ON THE EULER AND NAVIER-STOKES EQUATIONS USING CONTINUOUS/DISCONTINUOUS GALERKIN METHODS Sean L. Gibbons Captain, United

More information

F11AE1 1. C = ρν r r. r u z r

F11AE1 1. C = ρν r r. r u z r F11AE1 1 Question 1 20 Marks) Consider an infinite horizontal pipe with circular cross-section of radius a, whose centre line is aligned along the z-axis; see Figure 1. Assume no-slip boundary conditions

More information

Data assimilation in high dimensions

Data assimilation in high dimensions Data assimilation in high dimensions David Kelly Courant Institute New York University New York NY www.dtbkelly.com February 12, 2015 Graduate seminar, CIMS David Kelly (CIMS) Data assimilation February

More information

The Truth about diffusion (in liquids)

The Truth about diffusion (in liquids) The Truth about diffusion (in liquids) Aleksandar Donev Courant Institute, New York University & Eric Vanden-Eijnden, Courant In honor of Berni Julian Alder LLNL, August 20th 2015 A. Donev (CIMS) Diffusion

More information

A Stochastic Collocation based. for Data Assimilation

A Stochastic Collocation based. for Data Assimilation A Stochastic Collocation based Kalman Filter (SCKF) for Data Assimilation Lingzao Zeng and Dongxiao Zhang University of Southern California August 11, 2009 Los Angeles Outline Introduction SCKF Algorithm

More information

Differentiation. Timur Musin. October 10, University of Freiburg 1 / 54

Differentiation. Timur Musin. October 10, University of Freiburg 1 / 54 Timur Musin University of Freiburg October 10, 2014 1 / 54 1 Limit of a Function 2 2 / 54 Literature A. C. Chiang and K. Wainwright, Fundamental methods of mathematical economics, Irwin/McGraw-Hill, Boston,

More information

DATA ASSIMILATION FOR FLOOD FORECASTING

DATA ASSIMILATION FOR FLOOD FORECASTING DATA ASSIMILATION FOR FLOOD FORECASTING Arnold Heemin Delft University of Technology 09/16/14 1 Data assimilation is the incorporation of measurement into a numerical model to improve the model results

More information

Sampling the posterior: An approach to non-gaussian data assimilation

Sampling the posterior: An approach to non-gaussian data assimilation Physica D 230 (2007) 50 64 www.elsevier.com/locate/physd Sampling the posterior: An approach to non-gaussian data assimilation A. Apte a, M. Hairer b, A.M. Stuart b,, J. Voss b a Department of Mathematics,

More information

Lecture 9: Tidal Rectification, Stratification and Mixing

Lecture 9: Tidal Rectification, Stratification and Mixing Lecture 9: Tidal Rectification, Stratification and Mixing Chris Garrett 1 Additional Notes on Tidal Rectification This lecture continues the discussion of long-wavelength tidal flow over comparatively

More information

1,3. f x x f x x. Lim. Lim. Lim. Lim Lim. y 13x b b 10 b So the equation of the tangent line is y 13x

1,3. f x x f x x. Lim. Lim. Lim. Lim Lim. y 13x b b 10 b So the equation of the tangent line is y 13x 1.5 Topics: The Derivative lutions 1. Use the limit definition of derivative (the one with x in it) to find f x given f x 4x 5x 6 4 x x 5 x x 6 4x 5x 6 f x x f x f x x0 x x0 x xx x x x x x 4 5 6 4 5 6

More information

Formulas that must be memorized:

Formulas that must be memorized: Formulas that must be memorized: Position, Velocity, Acceleration Speed is increasing when v(t) and a(t) have the same signs. Speed is decreasing when v(t) and a(t) have different signs. Section I: Limits

More information

Eddy-diffusivity fields in turbulent transport: explicit expressions

Eddy-diffusivity fields in turbulent transport: explicit expressions DICCA University of Genova Italy Eddy-diffusivity fields in turbulent transport: explicit expressions Andrea Mazzino andrea.mazzino@unige.it Lagrangian transport: from complex flows to complex fluids Lecce

More information

2. Conservation of Mass

2. Conservation of Mass 2 Conservation of Mass The equation of mass conservation expresses a budget for the addition and removal of mass from a defined region of fluid Consider a fixed, non-deforming volume of fluid, V, called

More information

7.6 Example von Kármán s Laminar Boundary Layer Problem

7.6 Example von Kármán s Laminar Boundary Layer Problem CEE 3310 External Flows (Boundary Layers & Drag, Nov. 11, 2016 157 7.5 Review Non-Circular Pipes Laminar: f = 64/Re DH ± 40% Turbulent: f(re DH, ɛ/d H ) Moody chart for f ± 15% Bernoulli-Based Flow Metering

More information

Kalman Filter. Predict: Update: x k k 1 = F k x k 1 k 1 + B k u k P k k 1 = F k P k 1 k 1 F T k + Q

Kalman Filter. Predict: Update: x k k 1 = F k x k 1 k 1 + B k u k P k k 1 = F k P k 1 k 1 F T k + Q Kalman Filter Kalman Filter Predict: x k k 1 = F k x k 1 k 1 + B k u k P k k 1 = F k P k 1 k 1 F T k + Q Update: K = P k k 1 Hk T (H k P k k 1 Hk T + R) 1 x k k = x k k 1 + K(z k H k x k k 1 ) P k k =(I

More information

Starting from Heat Equation

Starting from Heat Equation Department of Applied Mathematics National Chiao Tung University Hsin-Chu 30010, TAIWAN 20th August 2009 Analytical Theory of Heat The differential equations of the propagation of heat express the most

More information