Impedance boundary conditions for general transient hemodynamics and other things

Size: px
Start display at page:

Download "Impedance boundary conditions for general transient hemodynamics and other things"

Transcription

1 Impedance boundary conditions for general transient hemodynamics and other things Will Cousins (MIT) Rachael Brag and Pierre Gremaud (NCSU) Vera Novak (BIDMC), Daniel Tartakovsky (UCSD) July 14, 2014

2 Overview Long term goal: non-invasive continuous measurement of cerebral blood flow (CBF) cheap" measurements: Transcranial Doppler to measure blood flow velocity (BFV) patient database and analysis thereof computational hemodynamics

3 Challenges In increasing order of stochasticity" closures for hemodynamics models: how to model what isn t in the computational domain (BCs) uncertainties in models, geometries and parameters uncertainties in data: lack of gold standard method, patient biases We need error bars to our predictions

4 This talk impedance boundary conditions (outflow) machine learning for CBF data (inflow)

5 Example: systemic arterial tree

6 Outflow BCs are fundamental inflow vessels: few and "easy" to measure DATA outflow vessels: many and hard to measure MODEL vasculature is reactive (autoregulation)

7 Arterial flow model: single vessel approach not interested in flow details but in vascular networks "throughput" one-d is often (but not always!) good enough computational justification (Grinberg et al., ABE, (2011)) derived BCs are general: can be adapted to multi-d

8 Arterial flow model: single vessel material assumptions incompressible Navier-Stokes flow is axisymmetric without swirls equations are averaged on cross-sections vessels are elastic

9 Arterial flow model: single vessel equations (Barnard et al., Biophys. J., 1966) where t Q + γ + 2 γ + 1 x ( Q 2 A A = A(x, t) surface area Q = Q(x, t) flowrate P = P(A) = P 0 + 4Eh 3r 0 (1 µ, ρ viscosity and density t A + x Q = 0 ) + A ρ xp = 2π(γ + 2) µ Q ρ A A 0 A γ flow profile (γ = 2 Poiseuille) ) pressure

10 Arterial flow model: single vessel Above equations are a system of hyperbolic balance laws At operating regime solutions are smooth (no shock!) Jacobian has one positive and one negative eigenvalue We need one inflow condition (measured velocity) one outflow condition At junctions conservation of mass continuity of pressure

11 Outflow BCs must mimic the part of the vasculature that is not modeled (downstream from computational domain) not create numerical artifacts be cheap to run be simple to implement require a minimum of calibration

12 Outflow BCs: the classics Dirichlet (or Neumann) BC impose a relationship between P and Q resistance: P = R Q RCR Windkessel: P + R 2 C t P = (R 1 + R 2 )Q + R 1 R 2 C t Q R. Saouti et al., Euro. Respir. Rev., 2010

13 Outflow BCs: the classics Dirichlet (or Neumann) BC impose a relationship between P and Q resistance: P = R Q Issues RCR Windkessel: limited physiological basis P + R 2 C t P = (R 1 + R 2 )Q + R 1 R 2 C t Q determination of parameter values

14 Impedance bc takes the form of a convolution z j s: impedance weights P n = n z j Q n j + P term j=0

15 Structured tree BC Proposed by M.G. Taylor (1966), developed by M. Olufsen (1999) assumes simplified fractal geometry of downstream vascular tree linearizes flow equations uses Fourier and junction conditions to define tree impedance

16 New impedance BC Fourier Laplace: allows general flows (instead of just periodic ones) fractal structure effective tiered structure: greatly reduces need for calibration can be used in lieu of calibration for other BCs better termination criterion

17 Tree geometry Governed by four rules rule 0: there are only bifurcations rule 1: r d1 = α r p, r d2 = β r p rule 2: l = λ r rule 3: terminate vessel if r < r min where r is radius, l is length and p and d i are parent/daughters Potential issue scaling parameters are not constant (more later)

18 Linearization (in A about A 0 ) C t P + x Q = 0 t Q + A 0 ρ xp = 2π(γ + 2) µ ρ where C = da/dp is the vessel compliance. We Laplace transform and solve exactly ( ) ( ) ˆQ(0, s) = sd s C ˆP(l, l s) sinh + d ˆQ(l, l s) cosh s d s ( ) ˆP(0, s) = ˆP(l, l s) cosh + 1 ( ) d s sd s C ˆQ(l, l s) sinh d s Q A 0

19 Vessel impedance Defined through its Laplace transform and thus Ẑ (x, s) = ˆP(x, s) ˆQ(x, s) Ẑ (0, s) = Ẑ (l, s) + 1 sd sc tanh L/d s sd s C Ẑ (l, s) tanh L/d s + 1 links the impedance at beginning and end of the vessel for imaginary s, i.e., s = iω, ω R, Ẑ is the "old" impedance

20 Tree impedance can be defined recursively using junction conditions conservation of mass: Q p (l, t) = Q d1 (0, t) + Q d2 (0, t) continuity of pressure: P p (l, t) = P d1 (0, t) = P d2 (0, t) 1 Ẑ pa (l, s) = 1 Ẑ d1 (0, s) + 1 Ẑ d2 (0, s)

21 First set Ẑ (s) = Ẑterm at terminals

22 Use Single Vessel Solution

23 Use Junction Relation

24 Use Single Vessel Solution

25 Use Junction Relation

26 Use Single Vessel Solution

27 Use Single Vessel Solution

28 Use Junction Relation

29 Use Single Vessel Solution

30 Use Junction Relation

31 Use Single Vessel Solution

32 Algorithm to compute impedance procedure IMPEDANCE Input: r - radius of vessel Output: ZPA_0 if r < r min then ZPA_L = Z term else ZD1 = IMPEDANCE(α r) ZD2 = IMPEDANCE(β r) ZPA_L = ZD1 ZD2/(ZD1 + ZD2) end if ZPA_0 = singlevesselimp(zpa_l) end procedure

33 Implementation: intro we have just computed Ẑ (s) convolution P(t) = t 0 Z (τ) Q(t τ) dτ Problem: we need Z = L 1 (Ẑ ) and L 1 is an ill-posed numerical nightmare

34 Implementation: trick convolution quadrature (Lubich, 1988) allows the calculation of (an approximation to) P P(t) = t 0 without having to compute Z Z (τ)q(t τ)dτ n z n j Q(j t) j=0

35 Implementation: CQ details Mellin s inversion formula Z (τ) = 1 ν+i 2πi ν i Ẑ (λ)eλτ dλ Theorem If Ẑterm has nonnegative real part, then Ẑ (s) is analytic for all Rs 0 except at s = 0, where it has a removable singularity ν+i Ẑ (λ) y(λ; t) dλ, ν i y(λ; P(t) = 1 2πi y as solution to ODE discretize ODE through multistep method t) = t 0 eλt Q(t τ) dτ re-express integral and efficient quadratures for Cauchy integrals...

36 Implementation procedure IMPEDANCEWEIGHTS Input: t f = final simulation time t = time step size N = number of time steps (N = t f / t) ɛ = accuracy of computation of Ẑ Output: impedance weights z n, n = 0,..., N M = 2N r = ɛ 1/2N for m = 0 : M 1 do ζ = re i2πm/m Ξ = 1 2 ζ2 2ζ Z (m) = Ẑ (Ξ/ t) end for for n = 0 : N do z n = r n M end for end procedure M 1 m=0 Z (m) e i2πmn/m

37 Implementation: cost impedance weights computed for each outflow prior to simulation requires 2N evaluations of Ẑ one eval. of Ẑ = O((#generations)2 ) operations (a few thousand) in short: it is cheap

38 Computational example consider specific network (Circle of Willis, "full body") use 1D nonlinear model t Q + γ + 2 γ + 1 x ( Q 2 A t A + x Q = 0 ) + A ρ xp = 2π(γ + 2) µ Q ρ A pseudospectral Chebyshev collocation in space 2nd order Backward Difference Formula in time inflow bc velocity measurements from V. Novak, BIDMC, Harvard outflow bc impedance

39 Look Ma No calibration!

40 Some implementation details r min taken as 30µm Z term = 0 is a terrible idea Can be corrected through P n = n z j Q n j + P term j=0 with P term 45 mmhg

41 Towards autoregulation What happens to the impedance under radii change? multiply tree vessel radii by C AR observe z k (C AR ) z k (1) e M ARk t, k = 0,..., N

42 Towards autoregulation (2) match has been checked over wide range of parameters memory" of structured tree.25 sec time scale of autoregulation responses 5-20 sec auto-regulation induced microvascular changes z k (M AR (t)) = z k e M AR(t)k t, k = 0,..., N. scalar (!) M AR is obtained from specific autoregulation model

43 Towards autoregulation (3) variation of tree resistance away from baseline value R eq = (P eq P term )/Q eq auxiliary equation dx AR dt ( ) Q(t) Qeq = G AR Q eq R AR obtained from x AR by imposing limits (sigmoid) M AR obtained from N z k (M AR ) = R AR k=0 N z k k=0

44 Towards autoregulation (4) impose P(t) = P baseline (t)f (t) at aorta 20% drop in MAP immediate flow decrease followed by return to baseline AP (mmhg) Time (s) CBV (cm / s) Time (s) x AR Time (s) R AR Time (s)

45 Database from BIDMC total male female participants age 66.5±8 65.6±9 67.3±8. group hyper % no hyper % total % control stroke DM

46 Database from BIDMC (2) For each patient: MCA data { BFV post-processed from Trans Cranial Doppler (TCD) CBF from CASL MRI HCT, CO 2 age, height, weight head size (front to back and side to side) gender, diabetes (y/n), hypertension (y/n) from lab from lab from lab from lab { radius R from images insonation angle θ from images M territory mass from maps" and post processing

47 TCD vs MRI Direct comparison between TCD-BFV and MRI-CBF

48 TCD vs MRI (2) Direct estimate: CBF TCD = πr2 M v 2 cos θ

49 Sources of uncertainties, TCD insonation angle velocity profile vessel radius territory mass

50 Sources of uncertainties, CASL MRI CASL MRI CBF is correlated with HCT% (r =.49, p = )

51 Predicting CBF? y : response variable CASL MRI CBF x: predictor variables, TCD BFV, age, height,... Prediction: y = f (x) based on partitioning the data and applying local models regression trees random forests

52 Trees and forests y i, i = 1,..., N (N observations) x i = (x i,1,..., x i,p ), i = 1,..., N, p = 14 parameter space: partitioned in K regions Ω k, k = 1,..., K response function approximated by y f (x) = K c k χ k (x) k=1 χ k = indicator function of Ω k ; c k = simple local model for instance c k = 1/ I k I k j=1 y j, I k = {j; x j Ω k } ideally, MSE 1 N N i=1 (y i f (x i )) 2 is minimized over all partitions Ω k, k = 1,..., K computational feasibility Ω k s taken as rectangular" and minimization replaced by recursive partitioning

53 Trees and forests (2) Trees as above can be unstable. Improvements: consider an ensemble of trees (bootstrapping) consider fixed number of predictive variables for splitting decreases tree correlation and estimate variance 0.9 Correlation Between Trees Number of Randomly Selected Fitting Variables m

54 Trees and forests (3) m = 1 m = 4 m = 5 m = 10 Out of Bag MSE Number of Trees m = 5 < p = 14 wins

55 Some results: correlation CASL MRI CBF out of bag prediction

56 Some results: variable importance Hypertension Area Head Length Diabetes Gender Angle Height HCT % Terr. Mass Head Width Age Weight C02 TCD BFV Average Error Increase

57 Some results: clustering Distance to Cluster 2 Centroid Cluster 1 Cluster Distance to Cluster 1 Centroid

58 Future work organ specific BCs analysis of role played by calibration efficient uncertainty representation in comp. hemodynamics local regression methods for patient clustering

59 references W. Cousins, P. Gremaud, Boundary conditions for hemodynamics: The structured tree revisited, J. Comput. Phys., 231 (2012), pp W. Cousins, P. Gremaud, D. Tartakovsky, A new physiological boundary condition for hemodynamics, SIAM J. Appl. Math., 73 (2013), pp W. Cousins, P. Gremaud, Impedance boundary conditions for general transient hemodynamics, Int. J. Numer. Meth. Biomed. Eng., in press. R. Bragg, P. Gremaud, V. Novak, Cerebral blood flow measurements: intersubject variability using MRI and Transcranial Doppler, in preparation

Mathematical Model. M. Umar Qureshi, Mitchel J. Colebank, and Mette S. Olufsen

Mathematical Model. M. Umar Qureshi, Mitchel J. Colebank, and Mette S. Olufsen Mathematical Model M. Umar Qureshi, Mitchel J. Colebank, and Mette S. Olufsen Department of Mathematics, North Carolina State University, Raleigh, North Carolina 27695 Friday 7 th September, 2018 The 1D

More information

System Level Acceleration: Applications in Cerebro vascular Perfusion. Tim David and Steve Moore

System Level Acceleration: Applications in Cerebro vascular Perfusion. Tim David and Steve Moore System Level Acceleration: Applications in Cerebro vascular Perfusion. Tim David and Steve Moore What is system level acceleration? the deployment of diverse compute resources to solve the problem of a

More information

Practice Problems For Test 3

Practice Problems For Test 3 Practice Problems For Test 3 Power Series Preliminary Material. Find the interval of convergence of the following. Be sure to determine the convergence at the endpoints. (a) ( ) k (x ) k (x 3) k= k (b)

More information

Arterial Macrocirculatory Hemodynamics

Arterial Macrocirculatory Hemodynamics Arterial Macrocirculatory Hemodynamics 莊漢聲助理教授 Prof. Han Sheng Chuang 9/20/2012 1 Arterial Macrocirculatory Hemodynamics Terminology: Hemodynamics, meaning literally "blood movement" is the study of blood

More information

Practice Problems For Test 3

Practice Problems For Test 3 Practice Problems For Test 3 Power Series Preliminary Material. Find the interval of convergence of the following. Be sure to determine the convergence at the endpoints. (a) ( ) k (x ) k (x 3) k= k (b)

More information

An Effective Fractal-Tree Closure Model for Simulating Blood Flow in Large Arterial Networks

An Effective Fractal-Tree Closure Model for Simulating Blood Flow in Large Arterial Networks Annals of Biomedical Engineering, Vol. 43, No. 6, June 2015 (Ó 2014) pp. 1432 1442 DOI: 10.1007/s10439-014-1221-3 An Effective Fractal-Tree Closure Model for Simulating Blood Flow in Large Arterial Networks

More information

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013 ADI iterations for general elliptic problems John Strain Mathematics Department UC Berkeley July 2013 1 OVERVIEW Classical alternating direction implicit (ADI) iteration Essentially optimal in simple domains

More information

Partial Differential Equations

Partial Differential Equations M3M3 Partial Differential Equations Solutions to problem sheet 3/4 1* (i) Show that the second order linear differential operators L and M, defined in some domain Ω R n, and given by Mφ = Lφ = j=1 j=1

More information

Abundance of cusps in semi-linear operators

Abundance of cusps in semi-linear operators Abundance of cusps in semi-linear operators Carlos Tomei, PUC-Rio with Marta Calanchi (U. Milano) and André Zaccur (PUC-Rio) RISM, Varese, September 2015 A simple example This will be essentially proved:

More information

An arbitrary lagrangian eulerian discontinuous galerkin approach to fluid-structure interaction and its application to cardiovascular problem

An arbitrary lagrangian eulerian discontinuous galerkin approach to fluid-structure interaction and its application to cardiovascular problem An arbitrary lagrangian eulerian discontinuous galerkin approach to fluid-structure interaction and its application to cardiovascular problem Yifan Wang University of Houston, Department of Mathematics

More information

Analysis and Simulation of Blood Flow in the Portal Vein with Uncertainty Quantification

Analysis and Simulation of Blood Flow in the Portal Vein with Uncertainty Quantification Analysis and Simulation of Blood Flow in the Portal Vein with Uncertainty Quantification João Pedro Carvalho Rêgo de Serra e Moura Instituto Superior Técnico Abstract Blood flow simulations in CFD are

More information

Alberto Bressan. Department of Mathematics, Penn State University

Alberto Bressan. Department of Mathematics, Penn State University Non-cooperative Differential Games A Homotopy Approach Alberto Bressan Department of Mathematics, Penn State University 1 Differential Games d dt x(t) = G(x(t), u 1(t), u 2 (t)), x(0) = y, u i (t) U i

More information

Final Exam May 4, 2016

Final Exam May 4, 2016 1 Math 425 / AMCS 525 Dr. DeTurck Final Exam May 4, 2016 You may use your book and notes on this exam. Show your work in the exam book. Work only the problems that correspond to the section that you prepared.

More information

Applications of the compensated compactness method on hyperbolic conservation systems

Applications of the compensated compactness method on hyperbolic conservation systems Applications of the compensated compactness method on hyperbolic conservation systems Yunguang Lu Department of Mathematics National University of Colombia e-mail:ylu@unal.edu.co ALAMMI 2009 In this talk,

More information

CAM Ph.D. Qualifying Exam in Numerical Analysis CONTENTS

CAM Ph.D. Qualifying Exam in Numerical Analysis CONTENTS CAM Ph.D. Qualifying Exam in Numerical Analysis CONTENTS Preliminaries Round-off errors and computer arithmetic, algorithms and convergence Solutions of Equations in One Variable Bisection method, fixed-point

More information

Discontinuous Galerkin methods for fractional diffusion problems

Discontinuous Galerkin methods for fractional diffusion problems Discontinuous Galerkin methods for fractional diffusion problems Bill McLean Kassem Mustapha School of Maths and Stats, University of NSW KFUPM, Dhahran Leipzig, 7 October, 2010 Outline Sub-diffusion Equation

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

International Journal of Scientific & Engineering Research, Volume 4, Issue 7, July-2013 ISSN

International Journal of Scientific & Engineering Research, Volume 4, Issue 7, July-2013 ISSN 648 Local sensitivity analysis of cardiovascular system parameters R. Gul and S. Bernhard, Fachbereich Mathematik, FU Berlin, Germany. Dept. of Electrical Engineering and Information Technology, Pforzheim

More information

METHODS FOR SOLVING MATHEMATICAL PHYSICS PROBLEMS

METHODS FOR SOLVING MATHEMATICAL PHYSICS PROBLEMS METHODS FOR SOLVING MATHEMATICAL PHYSICS PROBLEMS V.I. Agoshkov, P.B. Dubovski, V.P. Shutyaev CAMBRIDGE INTERNATIONAL SCIENCE PUBLISHING Contents PREFACE 1. MAIN PROBLEMS OF MATHEMATICAL PHYSICS 1 Main

More information

Explicit kernel-split panel-based Nyström schemes for planar or axisymmetric Helmholtz problems

Explicit kernel-split panel-based Nyström schemes for planar or axisymmetric Helmholtz problems z Explicit kernel-split panel-based Nyström schemes for planar or axisymmetric Helmholtz problems Johan Helsing Lund University Talk at Integral equation methods: fast algorithms and applications, Banff,

More information

Deforming Composite Grids for Fluid Structure Interactions

Deforming Composite Grids for Fluid Structure Interactions Deforming Composite Grids for Fluid Structure Interactions Jeff Banks 1, Bill Henshaw 1, Don Schwendeman 2 1 Center for Applied Scientific Computing, Lawrence Livermore National Laboratory, Livermore,

More information

The dependence of the cross-sectional shape on the hydraulic resistance of microchannels

The dependence of the cross-sectional shape on the hydraulic resistance of microchannels 3-weeks course report, s0973 The dependence of the cross-sectional shape on the hydraulic resistance of microchannels Hatim Azzouz a Supervisor: Niels Asger Mortensen and Henrik Bruus MIC Department of

More information

EE C128 / ME C134 Final Exam Fall 2014

EE C128 / ME C134 Final Exam Fall 2014 EE C128 / ME C134 Final Exam Fall 2014 December 19, 2014 Your PRINTED FULL NAME Your STUDENT ID NUMBER Number of additional sheets 1. No computers, no tablets, no connected device (phone etc.) 2. Pocket

More information

u xx + u yy = 0. (5.1)

u xx + u yy = 0. (5.1) Chapter 5 Laplace Equation The following equation is called Laplace equation in two independent variables x, y: The non-homogeneous problem u xx + u yy =. (5.1) u xx + u yy = F, (5.) where F is a function

More information

High Order Numerical Methods for the Riesz Derivatives and the Space Riesz Fractional Differential Equation

High Order Numerical Methods for the Riesz Derivatives and the Space Riesz Fractional Differential Equation International Symposium on Fractional PDEs: Theory, Numerics and Applications June 3-5, 013, Salve Regina University High Order Numerical Methods for the Riesz Derivatives and the Space Riesz Fractional

More information

Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain

Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain Ming-Chih Lai Department of Applied Mathematics National Chiao Tung University 1001, Ta Hsueh Road, Hsinchu 30050 Taiwan Received 14 October

More information

CONDITIONAL JOINT TRANSFER ENTROPY OF CARDIOVASCULAR AND CEREBROVASCULAR CONTROL SYSTEMS IN SUBJECTS PRONE TO POSTURAL SYNCOPE

CONDITIONAL JOINT TRANSFER ENTROPY OF CARDIOVASCULAR AND CEREBROVASCULAR CONTROL SYSTEMS IN SUBJECTS PRONE TO POSTURAL SYNCOPE CONDITIONAL JOINT TRANSFER ENTROPY OF CARDIOVASCULAR AND CEREBROVASCULAR CONTROL SYSTEMS IN SUBJECTS PRONE TO POSTURAL SYNCOPE Vlasta Bari 1, Andrea Marchi 2,3, Beatrice De Maria 2,4, Gianluca Rossato

More information

Numerical Simulation and Experimental Validation of Blood Flow in Arteries with Structured-Tree Outflow Conditions

Numerical Simulation and Experimental Validation of Blood Flow in Arteries with Structured-Tree Outflow Conditions Annals of Biomedical Engineering, Vol. 28, pp. 1281 1299, 2 Printed in the USA. All rights reserved. 9-6964/2/2811/1281/19/$15. Copyright 2 Biomedical Engineering Society Numerical Simulation and Experimental

More information

Bayesian Nonparametric Accelerated Failure Time Models for Analyzing Heterogeneous Treatment Effects

Bayesian Nonparametric Accelerated Failure Time Models for Analyzing Heterogeneous Treatment Effects Bayesian Nonparametric Accelerated Failure Time Models for Analyzing Heterogeneous Treatment Effects Nicholas C. Henderson Thomas A. Louis Gary Rosner Ravi Varadhan Johns Hopkins University September 28,

More information

Rank-Deficient Nonlinear Least Squares Problems and Subset Selection

Rank-Deficient Nonlinear Least Squares Problems and Subset Selection Rank-Deficient Nonlinear Least Squares Problems and Subset Selection Ilse Ipsen North Carolina State University Raleigh, NC, USA Joint work with: Tim Kelley and Scott Pope Motivating Application Overview

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

Week 2 Notes, Math 865, Tanveer

Week 2 Notes, Math 865, Tanveer Week 2 Notes, Math 865, Tanveer 1. Incompressible constant density equations in different forms Recall we derived the Navier-Stokes equation for incompressible constant density, i.e. homogeneous flows:

More information

One Dimensional Simulations of Cerebral Blood Flow

One Dimensional Simulations of Cerebral Blood Flow One Dimensional Simulations of Cerebral Blood Flow Elizabeth Cheever Applied Mathematics Brown University A thesis submitted for Honors for the degree of Sc.B. Applied Mathematics - Computer Science May

More information

M.Sc. in Meteorology. Numerical Weather Prediction

M.Sc. in Meteorology. Numerical Weather Prediction M.Sc. in Meteorology UCD Numerical Weather Prediction Prof Peter Lynch Meteorology & Climate Centre School of Mathematical Sciences University College Dublin Second Semester, 2005 2006. In this section

More information

FINITE TIME BLOW-UP FOR A DYADIC MODEL OF THE EULER EQUATIONS

FINITE TIME BLOW-UP FOR A DYADIC MODEL OF THE EULER EQUATIONS TRANSACTIONS OF THE AMERICAN MATHEMATICAL SOCIETY Volume 357, Number 2, Pages 695 708 S 0002-9947(04)03532-9 Article electronically published on March 12, 2004 FINITE TIME BLOW-UP FOR A DYADIC MODEL OF

More information

Hemodynamics II. Aslı AYKAÇ, PhD. NEU Faculty of Medicine Department of Biophysics

Hemodynamics II. Aslı AYKAÇ, PhD. NEU Faculty of Medicine Department of Biophysics Hemodynamics II Aslı AYKAÇ, PhD. NEU Faculty of Medicine Department of Biophysics Laplace s Law Relates the pressure difference across a closed elastic membrane on liquid film to the tension in the membrane

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

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

Electromagnetic Modeling and Simulation

Electromagnetic Modeling and Simulation Electromagnetic Modeling and Simulation Erin Bela and Erik Hortsch Department of Mathematics Research Experiences for Undergraduates April 7, 2011 Bela and Hortsch (OSU) EM REU 2010 1 / 45 Maxwell s Equations

More information

Table of Contents. II. PDE classification II.1. Motivation and Examples. II.2. Classification. II.3. Well-posedness according to Hadamard

Table of Contents. II. PDE classification II.1. Motivation and Examples. II.2. Classification. II.3. Well-posedness according to Hadamard Table of Contents II. PDE classification II.. Motivation and Examples II.2. Classification II.3. Well-posedness according to Hadamard Chapter II (ContentChapterII) Crashtest: Reality Simulation http:www.ara.comprojectssvocrownvic.htm

More information

A fast and well-conditioned spectral method: The US method

A fast and well-conditioned spectral method: The US method A fast and well-conditioned spectral method: The US method Alex Townsend University of Oxford Leslie Fox Prize, 24th of June 23 Partially based on: S. Olver & T., A fast and well-conditioned spectral method,

More information

WEYL S LEMMA, ONE OF MANY. Daniel W. Stroock

WEYL S LEMMA, ONE OF MANY. Daniel W. Stroock WEYL S LEMMA, ONE OF MANY Daniel W Stroock Abstract This note is a brief, and somewhat biased, account of the evolution of what people working in PDE s call Weyl s Lemma about the regularity of solutions

More information

Error Analyses of Stabilized Pseudo-Derivative MLS Methods

Error Analyses of Stabilized Pseudo-Derivative MLS Methods Department of Mathematical Sciences Revision: April 11, 2015 Error Analyses of Stabilized Pseudo-Derivative MLS Methods Don French, M. Osorio and J. Clack Moving least square (MLS) methods are a popular

More information

PhD Course in Biomechanical Modelling Assignment: Pulse wave propagation in arteries

PhD Course in Biomechanical Modelling Assignment: Pulse wave propagation in arteries PhD Course in Biomechanical Modelling Assignment: Pulse wave propagation in arteries Jonas Stålhand Division of Mechanics, Linköping University September 2012 1 The assignment Your first task is to derive

More information

PoS(LAT2009)061. Monte Carlo approach to turbulence

PoS(LAT2009)061. Monte Carlo approach to turbulence P. Düben a, D. Homeier a, K. Jansen b, D. Mesterhazy c and a a Westfälische Wilhelms-Universität, Intitut für Theoretische Physik Wilhelm-Klemm-Str. 9, 48149 Münster, Germany b NIC, DESY Zeuthen Platanenallee

More information

A Preliminary Fractional Calculus Model of the Aortic Pressure Flow Relationship during Systole

A Preliminary Fractional Calculus Model of the Aortic Pressure Flow Relationship during Systole Proceedings of the International Conference on Biomedical Engineering and Systems Prague, Czech Republic, August 14-15, 2014 Paper No. 34 A Preliminary Fractional Calculus Model of the Aortic Pressure

More information

BME 419/519 Hernandez 2002

BME 419/519 Hernandez 2002 Vascular Biology 2 - Hemodynamics A. Flow relationships : some basic definitions Q v = A v = velocity, Q = flow rate A = cross sectional area Ohm s Law for fluids: Flow is driven by a pressure gradient

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

Contents (I): The model: The physical scenario and the derivation of the model: Muskat and the confined Hele-Shaw cell problems.

Contents (I): The model: The physical scenario and the derivation of the model: Muskat and the confined Hele-Shaw cell problems. Contents (I): The model: The physical scenario and the derivation of the model: Muskat and the confined Hele-Shaw cell problems. First ideas and results: Existence and uniqueness But, are the boundaries

More information

Numerically computing zeros of the Evans Function

Numerically computing zeros of the Evans Function Numerically computing zeros of the Evans Function Rebekah Coggin Department of Mathematics and Statistics Calvin College Grand Rapids, MI 49546 Faculty Advisor: Todd Kapitula Department of Mathematics

More information

Modal Decomposition Methods on Aerodynamic Flows

Modal Decomposition Methods on Aerodynamic Flows 498 Modal Decomposition Methods on Aerodynamic Flows Mohammad Niaz Murshed University of Michigan Department of Aerospace Engineering February 5, 2018 Abstract- This paper discusses the significance of

More information

Determination of pressure data in aortic valves

Determination of pressure data in aortic valves Determination of pressure data in aortic valves Helena Švihlová a, Jaroslav Hron a, Josef Málek a, K.R.Rajagopal b and Keshava Rajagopal c a, Mathematical Institute, Charles University, Czech Republic

More information

Comparing Poiseuille with 1D. Navier-Stokes Flow in Rigid and. Distensible Tubes and Networks

Comparing Poiseuille with 1D. Navier-Stokes Flow in Rigid and. Distensible Tubes and Networks arxiv:135.2546v1 [physics.flu-dyn] 11 May 213 Comparing oiseuille with 1D Navier-Stokes Flow in Rigid and Distensible Tubes and Networks Taha Sochi March 17, 218 Imaging Sciences & Biomedical Engineering,

More information

A Multiphysics Strategy for Free Surface Flows

A Multiphysics Strategy for Free Surface Flows A Multiphysics Strategy for Free Surface Flows Edie Miglio, Simona Perotto, and Fausto Saleri MOX, Modeling and Scientific Computing, Department of Mathematics, Politecnico of Milano, via Bonardi 9, I-133

More information

Numerical modelling of shear-thinning non-newtonian flows in compliant vessels

Numerical modelling of shear-thinning non-newtonian flows in compliant vessels INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2007; 00:1 [Version: 2002/09/18 v1.01] Numerical modelling of shear-thinning non-newtonian flows in compliant vessels M.

More information

Numerical methods for non-standard fractional operators in the simulation of dielectric materials

Numerical methods for non-standard fractional operators in the simulation of dielectric materials Numerical methods for non-standard fractional operators in the simulation of dielectric materials Roberto Garrappa Department of Mathematics - University of Bari - Italy roberto.garrappa@uniba.it Fractional

More information

ENGI 9420 Lecture Notes 1 - ODEs Page 1.01

ENGI 9420 Lecture Notes 1 - ODEs Page 1.01 ENGI 940 Lecture Notes - ODEs Page.0. Ordinary Differential Equations An equation involving a function of one independent variable and the derivative(s) of that function is an ordinary differential equation

More information

BAGGING PREDICTORS AND RANDOM FOREST

BAGGING PREDICTORS AND RANDOM FOREST BAGGING PREDICTORS AND RANDOM FOREST DANA KANER M.SC. SEMINAR IN STATISTICS, MAY 2017 BAGIGNG PREDICTORS / LEO BREIMAN, 1996 RANDOM FORESTS / LEO BREIMAN, 2001 THE ELEMENTS OF STATISTICAL LEARNING (CHAPTERS

More information

Evolution of semiclassical Wigner function (the higher dimensio

Evolution of semiclassical Wigner function (the higher dimensio Evolution of semiclassical Wigner function (the higher dimensional case) Workshop on Fast Computations in Phase Space, WPI-Vienna, November 2008 Dept. Appl. Math., Univ. Crete & IACM-FORTH 1 2 3 4 5 6

More information

Statistics and learning: Big Data

Statistics and learning: Big Data Statistics and learning: Big Data Learning Decision Trees and an Introduction to Boosting Sébastien Gadat Toulouse School of Economics February 2017 S. Gadat (TSE) SAD 2013 1 / 30 Keywords Decision trees

More information

Taylor and Laurent Series

Taylor and Laurent Series Chapter 4 Taylor and Laurent Series 4.. Taylor Series 4... Taylor Series for Holomorphic Functions. In Real Analysis, the Taylor series of a given function f : R R is given by: f (x + f (x (x x + f (x

More information

arxiv: v4 [physics.comp-ph] 21 Jan 2019

arxiv: v4 [physics.comp-ph] 21 Jan 2019 A spectral/hp element MHD solver Alexander V. Proskurin,Anatoly M. Sagalakov 2 Altai State Technical University, 65638, Russian Federation, Barnaul, Lenin prospect,46, k2@list.ru 2 Altai State University,

More information

Introduction to uncertainty quantification An example of application in medicine

Introduction to uncertainty quantification An example of application in medicine Introduction to uncertainty quantification An example of application in medicine Laurent Dumas Laboratoire de Mathématiques de Versailles (LMV) Versailles University Short course, University of Mauritius,

More information

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018 Numerical Analysis Preliminary Exam 1 am to 1 pm, August 2, 218 Instructions. You have three hours to complete this exam. Submit solutions to four (and no more) of the following six problems. Please start

More information

Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method

Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method Y. Azari Keywords: Local RBF-based finite difference (LRBF-FD), Global RBF collocation, sine-gordon

More information

Solving PDEs with freefem++

Solving PDEs with freefem++ Solving PDEs with freefem++ Tutorials at Basque Center BCA Olivier Pironneau 1 with Frederic Hecht, LJLL-University of Paris VI 1 March 13, 2011 Do not forget That everything about freefem++ is at www.freefem.org

More information

Stochastic excitation of streaky boundary layers. Luca Brandt, Dan Henningson Department of Mechanics, KTH, Sweden

Stochastic excitation of streaky boundary layers. Luca Brandt, Dan Henningson Department of Mechanics, KTH, Sweden Stochastic excitation of streaky boundary layers Jérôme Hœpffner Luca Brandt, Dan Henningson Department of Mechanics, KTH, Sweden Boundary layer excited by free-stream turbulence Fully turbulent inflow

More information

An inverse elliptic problem of medical optics with experimental data

An inverse elliptic problem of medical optics with experimental data An inverse elliptic problem of medical optics with experimental data Jianzhong Su, Michael V. Klibanov, Yueming Liu, Zhijin Lin Natee Pantong and Hanli Liu Abstract A numerical method for an inverse problem

More information

THE POSTPROCESSING GALERKIN AND NONLINEAR GALERKIN METHODS A TRUNCATION ANALYSIS POINT OF VIEW

THE POSTPROCESSING GALERKIN AND NONLINEAR GALERKIN METHODS A TRUNCATION ANALYSIS POINT OF VIEW SIAM J. NUMER. ANAL. Vol. 41, No. 2, pp. 695 714 c 2003 Society for Industrial and Applied Mathematics THE POSTPROCESSING GALERKIN AND NONLINEAR GALERKIN METHODS A TRUNCATION ANALYSIS POINT OF VIEW LEN

More information

Electrical circuits as manifolds Introduction

Electrical circuits as manifolds Introduction Electrical circuits as manifolds Introduction Once we have shown how to make a link between electrical networks and parametrized surfaces, it becomes interesting to look at circuits like manifolds. Kron

More information

PROBLEM SET 6. SOLUTIONS April 1, 2004

PROBLEM SET 6. SOLUTIONS April 1, 2004 Harvard-MIT Division of Health Sciences and Technology HST.54J: Quantitative Physiology: Organ Transport Systems Instructors: Roger Mark and Jose Venegas MASSACHUSETTS INSTITUTE OF TECHNOLOGY Departments

More information

Rapid Design of Subcritical Airfoils. Prabir Daripa Department of Mathematics Texas A&M University

Rapid Design of Subcritical Airfoils. Prabir Daripa Department of Mathematics Texas A&M University Rapid Design of Subcritical Airfoils Prabir Daripa Department of Mathematics Texas A&M University email: daripa@math.tamu.edu In this paper, we present a fast, efficient and accurate algorithm for rapid

More information

Figure 1: Grad, Div, Curl, Laplacian in Cartesian, cylindrical, and spherical coordinates. Here ψ is a scalar function and A is a vector field.

Figure 1: Grad, Div, Curl, Laplacian in Cartesian, cylindrical, and spherical coordinates. Here ψ is a scalar function and A is a vector field. Figure 1: Grad, Div, Curl, Laplacian in Cartesian, cylindrical, and spherical coordinates. Here ψ is a scalar function and A is a vector field. Figure 2: Vector and integral identities. Here ψ is a scalar

More information

PARAMETRIC STUDY OF FRACTIONAL BIOHEAT EQUATION IN SKIN TISSUE WITH SINUSOIDAL HEAT FLUX. 1. Introduction

PARAMETRIC STUDY OF FRACTIONAL BIOHEAT EQUATION IN SKIN TISSUE WITH SINUSOIDAL HEAT FLUX. 1. Introduction Fractional Differential Calculus Volume 5, Number 1 (15), 43 53 doi:10.7153/fdc-05-04 PARAMETRIC STUDY OF FRACTIONAL BIOHEAT EQUATION IN SKIN TISSUE WITH SINUSOIDAL HEAT FLUX R. S. DAMOR, SUSHIL KUMAR

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Philippe B. Laval KSU Current Semester Philippe B. Laval (KSU) Key Concepts Current Semester 1 / 25 Introduction The purpose of this section is to define

More information

HST 583 FUNCTIONAL MAGNETIC RESONANCE IMAGING DATA ANALYSIS AND ACQUISITION A REVIEW OF STATISTICS FOR FMRI DATA ANALYSIS

HST 583 FUNCTIONAL MAGNETIC RESONANCE IMAGING DATA ANALYSIS AND ACQUISITION A REVIEW OF STATISTICS FOR FMRI DATA ANALYSIS HST 583 FUNCTIONAL MAGNETIC RESONANCE IMAGING DATA ANALYSIS AND ACQUISITION A REVIEW OF STATISTICS FOR FMRI DATA ANALYSIS EMERY N. BROWN AND CHRIS LONG NEUROSCIENCE STATISTICS RESEARCH LABORATORY DEPARTMENT

More information

NUMERICAL SIMULATION OF INTERACTION BETWEEN INCOMPRESSIBLE FLOW AND AN ELASTIC WALL

NUMERICAL SIMULATION OF INTERACTION BETWEEN INCOMPRESSIBLE FLOW AND AN ELASTIC WALL Proceedings of ALGORITMY 212 pp. 29 218 NUMERICAL SIMULATION OF INTERACTION BETWEEN INCOMPRESSIBLE FLOW AND AN ELASTIC WALL MARTIN HADRAVA, MILOSLAV FEISTAUER, AND PETR SVÁČEK Abstract. The present paper

More information

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

CHAPTER 5: Linear Multistep Methods

CHAPTER 5: Linear Multistep Methods CHAPTER 5: Linear Multistep Methods Multistep: use information from many steps Higher order possible with fewer function evaluations than with RK. Convenient error estimates. Changing stepsize or order

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

QUINTIC SPLINE SOLUTIONS OF FOURTH ORDER BOUNDARY-VALUE PROBLEMS

QUINTIC SPLINE SOLUTIONS OF FOURTH ORDER BOUNDARY-VALUE PROBLEMS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 5, Number, Pages 0 c 2008 Institute for Scientific Computing Information QUINTIC SPLINE SOLUTIONS OF FOURTH ORDER BOUNDARY-VALUE PROBLEMS

More information

PONDI CHERRY UNI VERSI TY

PONDI CHERRY UNI VERSI TY B.Sc. ALLIED MATHEMATICS SYLLABUS 2009-2010 onwards PONDI CHERRY UNI VERSI TY PUDUCHERRY 605 014 B.Sc. ALLIED MATHEMATICS Syllabus for Allied Mathematics for B.Sc. Physics Main/Chemistry Main/Electronics

More information

A preliminary fractional calculus model of the aortic pressure flow relationship during systole

A preliminary fractional calculus model of the aortic pressure flow relationship during systole A preliminary fractional calculus model of the aortic pressure flow relationship during systole Glen Atlas Rutgers ew Jersey Medical School Dept. of Anesthesiology ewark, ew Jersey, USA atlasgm@njms.rutgers.edu

More information

A Direct Method for reconstructing inclusions from Electrostatic Data

A Direct Method for reconstructing inclusions from Electrostatic Data A Direct Method for reconstructing inclusions from Electrostatic Data Isaac Harris Texas A&M University, Department of Mathematics College Station, Texas 77843-3368 iharris@math.tamu.edu Joint work with:

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

Reading: P1-P20 of Durran, Chapter 1 of Lapidus and Pinder (Numerical solution of Partial Differential Equations in Science and Engineering)

Reading: P1-P20 of Durran, Chapter 1 of Lapidus and Pinder (Numerical solution of Partial Differential Equations in Science and Engineering) Chapter 1. Partial Differential Equations Reading: P1-P0 of Durran, Chapter 1 of Lapidus and Pinder (Numerical solution of Partial Differential Equations in Science and Engineering) Before even looking

More information

c 2008 Society for Industrial and Applied Mathematics

c 2008 Society for Industrial and Applied Mathematics MULTISCALE MODEL. SIMUL. Vol. 7, No. 2, pp. 888 909 c 2008 Society for Industrial and Applied Mathematics BLOOD FLOW IN THE CIRCLE OF WILLIS: MODELING AND CALIBRATION KRISTEN DEVAULT, PIERRE A. GREMAUD,

More information

Partitioned Methods for Multifield Problems

Partitioned Methods for Multifield Problems C Partitioned Methods for Multifield Problems Joachim Rang, 6.7.2016 6.7.2016 Joachim Rang Partitioned Methods for Multifield Problems Seite 1 C One-dimensional piston problem fixed wall Fluid flexible

More information

Research Statement. Tonatiuh Sánchez-Vizuet

Research Statement. Tonatiuh Sánchez-Vizuet {tonatiuh@cims.nyu.edu} http://cims.nyu.edu/~tonatiuh/ I am especially interested in devising, rigorously analyzing and implementing methods for the numerical simulation of transient wave phenomena. During

More information

Introduction to Signals and Systems General Informations. Guillaume Drion Academic year

Introduction to Signals and Systems General Informations. Guillaume Drion Academic year Introduction to Signals and Systems General Informations Guillaume Drion Academic year 2017-2018 SYST0002 - General informations Website: http://sites.google.com/site/gdrion25/teaching/syst0002 Contacts:

More information

Final: Solutions Math 118A, Fall 2013

Final: Solutions Math 118A, Fall 2013 Final: Solutions Math 118A, Fall 2013 1. [20 pts] For each of the following PDEs for u(x, y), give their order and say if they are nonlinear or linear. If they are linear, say if they are homogeneous or

More information

Matrix power converters: spectra and stability

Matrix power converters: spectra and stability Matrix power converters: spectra and stability Stephen Cox School of Mathematical Sciences, University of Nottingham supported by EPSRC grant number EP/E018580/1 Making It Real Seminar, Bristol 2009 Stephen

More information

Detailed 3D modelling of mass transfer processes in two phase flows with dynamic interfaces

Detailed 3D modelling of mass transfer processes in two phase flows with dynamic interfaces Detailed 3D modelling of mass transfer processes in two phase flows with dynamic interfaces D. Darmana, N.G. Deen, J.A.M. Kuipers Fundamentals of Chemical Reaction Engineering, Faculty of Science and Technology,

More information

8.4 Application to Economics/ Biology & Probability

8.4 Application to Economics/ Biology & Probability 8.4 Application to Economics/ Biology & 8.5 - Probability http://classic.hippocampus.org/course_locat or?course=general+calculus+ii&lesson=62&t opic=2&width=800&height=684&topictitle= Costs+&+probability&skinPath=http%3A%2F%

More information

Mathematical Model of Blood Flow in Carotid Bifurcation

Mathematical Model of Blood Flow in Carotid Bifurcation Excerpt from the Proceedings of the COMSOL Conference 2009 Milan Mathematical Model of Blood Flow in Carotid Bifurcation E. Muraca *,1, V. Gramigna 1, and G. Fragomeni 1 1 Department of Experimental Medicine

More information

21 Laplace s Equation and Harmonic Functions

21 Laplace s Equation and Harmonic Functions 2 Laplace s Equation and Harmonic Functions 2. Introductory Remarks on the Laplacian operator Given a domain Ω R d, then 2 u = div(grad u) = in Ω () is Laplace s equation defined in Ω. If d = 2, in cartesian

More information

Zero dispersion and viscosity limits of invariant manifolds for focusing nonlinear Schrödinger. equations

Zero dispersion and viscosity limits of invariant manifolds for focusing nonlinear Schrödinger. equations J. Math. Anal. Appl. 315 (2006) 642 655 www.elsevier.com/locate/jmaa Zero dispersion and viscosity limits of invariant manifolds for focusing nonlinear Schrödinger equations Y. Charles Li Department of

More information

Conformal maps. Lent 2019 COMPLEX METHODS G. Taylor. A star means optional and not necessarily harder.

Conformal maps. Lent 2019 COMPLEX METHODS G. Taylor. A star means optional and not necessarily harder. Lent 29 COMPLEX METHODS G. Taylor A star means optional and not necessarily harder. Conformal maps. (i) Let f(z) = az + b, with ad bc. Where in C is f conformal? cz + d (ii) Let f(z) = z +. What are the

More information

Physics 6303 Lecture 8 September 25, 2017

Physics 6303 Lecture 8 September 25, 2017 Physics 6303 Lecture 8 September 25, 2017 LAST TIME: Finished tensors, vectors, and matrices At the beginning of the course, I wrote several partial differential equations (PDEs) that are used in many

More information