SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY MODELS VIA AUTOMATIC DIFFERENTIATION

Size: px
Start display at page:

Download "SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY MODELS VIA AUTOMATIC DIFFERENTIATION"

Transcription

1 REPORT ON COMPUTATIONAL MATHEMATICS 7/99, DEPARTMENT OF MATHEMATICS, THE UNI- VERSITY OF IOWA SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY MODELS VIA AUTOMATIC DIFFERENTIATION A. SANDU, G. R. CARMICHAEL, AND F. A. POTRA Abstract. Automatic differentiation techniques are used in the sensitivity analysis of a comprehensive atmospheric chemical mechanism. Specifically, ADIFOR software is used to calculate the sensitivity of ozone with respect to all initial concentrations (of 8 species) and all reaction rate constants (78 chemical reactions) for six different chemical regions. Numerical aspects of the application of ADIFOR are also presented. Automatic differentiation is shown to be a powerful tool for sensitivity analysis. Key words. Atmospheric chemistry, Automatic Differentiation.. Introduction. Comprehensive sensitivity analysis of air pollution models remains the exception rather than the rule. Most sensitivity analysis applied to air pollution modeling studies has focused on the calculation of the local sensitivities (first order derivatives of output variables with respect to model parameters) in box model studies of gas phase chemistry (see [8]). The most common form of sensitivity studies with comprehensive atmospheric chemistry/transport models has been done using the so-called brute force method, i.e., a number of input parameters are selected to be varied and the simulation results are then compared. This method becomes less viable as the model becomes more comprehensive. A variety of alternative techniques are available including Green s function analysis (see [8]), adjoint models and several variations of the direct decoupled methods ( see [9]). A recently developed technique for sensitivity study is automatic differentiation technology. Automatic differentiation is implemented by pre compilers that analyze the code written for evaluating a function of several variables. These pre compilers automatically add instructions needed to compute the required derivatives by properly handling quantities that are common to the function and its derivatives and by efficient use of available derivatives in a library. The resulting expanded code is then compiled with a standard compiler into an object code that can simultaneously evaluate derivatives and function values. This approach is superior to finite difference approximation of the derivatives because the numerical values of the computed This work was supported by the grant no. DE FG0 9ER8 from the Department of Energy and by the Center for Global and Regional Environmental Research. Program in Applied Mathematics and Computational Sciences, The University of Iowa, Iowa City, IA (sandu@cgrer.uiowa.edu). Center for Global and Regional Environmental Research and the Department of Chemical and Biochemical Engineering The University of Iowa, Iowa City, IA (gcarmich@icaen.uiowa.edu). Departments of Mathematics and Computer Science, The University of Iowa, Iowa City, IA (potra@math.uiowa.edu).

2 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA derivatives are much more accurate and the computational effort is significantly lower (see [], []). A promising new implementation developed at Argonne National Laboratory and Rice University over the last couple of years and which has recently been awarded the 99 Wilkinson Prize for Numerical Software is the package ADIFOR (Automatic Differentiation in FORTRAN, see []). It adopts a hybrid approach to computing derivatives that is generally based on the forward mode, but uses the reverse mode to compute the derivatives of assignment statements containing complicated expressions. The forward mode acts similarly to the usual application of the chain rule in calculus. At each computational stage derivatives of the intermediate variables with respect to input variables are computed and are propagated forward through the computational stages. On the other hand the reverse mode is based on adjoint quantities representing derivatives of the output with respect to intermediate variables. The adjoints are computed at each node of the computational graph and they are propagated by reversing the flow of the program and by recomputing intermediate values that have a nonlinear impact on the output. It turns out that this approach is related to the adjoint sensitivity analysis used in such various fields as nuclear engineering (see []), weather forecast (see []) and neural networks (see [0]). Because assignment statements compute generally one dependent variable in terms of several dependent variables, the reverse mode is very efficient and can be implemented as in-line code. ADIFOR requires the user to supply the FORTRAN source code for the function value and for all lower level subroutines as well as a list of the independent and dependent variables in the form of parameter lists or common blocks. ADIFOR then determines which other variables throughout the programs are to be differentiated, and augments the original code with derivative statements. The augmented code is then optimized by eliminating unnecessary operations and temporary variables. The FORTRAN code generated by ADIFOR requires no run-time support and therefore can be ported between different computing environments. In this paper we demonstrate the use of ADIFOR in the sensitivity analysis of a comprehensive gas phase chemical box model. We first present a general description of automatic differentiation and its application along with chemical integrators. Automatic differentiation is then used to calculate first order sensitivities with respect to initial conditions and chemical reaction rate constants for a wide range of chemical conditions corresponding to the IPCC Chemistry Intercomparison study (see [8]).. Preliminaries. If c i (t) is the concentration of the i th species, the kinetics of a chemical system is described as an initial value problem: () dc i (t) = f(t, c,..., c n, β,..., β m ), dt c i (t 0 ) = c 0 i, i = n Intergovernmental Panel on Climate Change.

3 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD where β j, j =,..., m are the parameters of the system (for example, reaction rate constants, etc). The system () can be rewritten in matrix production - destruction form as: () dc(t) dt = P (c(t)) D(c(t)) c(t) where P R n, D R n n, D = diag(d i ) are the production and the destruction terms, respectively. The local sensitivity coefficients are defined as: () s i,j (t) = c i α j where α j represent either the initial values c 0 j or the parameter β j. The term local refers to the fact that these sensitivities describe the system around a given set of values for the parameters α. The system being considered to respond linearly for small perturbations, s i,j measures the ratio between the effect (absolute variation of the output c i ) and the cause (absolute variation of the input α j ). It is sometimes useful to consider the ratio between the relative variation of the output and the relative variation of the input: s i,j = α j c i s i,j = ln(c i) ln(α j ) c i c i ( αj where s i,j is the normalized sensitivity coefficient. The normalized coefficients have the advantage of being adimensional, hence useful when comparing sensitivities with respect to parameters whose absolute values are orders of magnitude apart. If α j = α j then α j = α j + α j = α j and we have the following interpretation: s i,j is the relative variation in c i when the parameter α j doubles its value, if the system responded linearly. The disadvantage of the normalized coefficients is that they are not defined for c i = 0. To overcome this drawback, one may consider the semi-normalised sensitivities s + i,j, representing the absolute variation in c i when α j doubles its value (if the system responded linearly): s + i,j = α j s i,j = c i ln(α j ) c i α j ( αj. Overview of some computational methods for sensitivity analysis. There are many ways to compute sensitivities. In this paper we employ three different methods to compute the local sensitivity coefficients. Conceptually, all three are Other techniques for sensitivity analysis, besides those described here, are available as well; one could mention Green s function method and adjoint models. Their description is beyond the scope of this paper. α j ) )

4 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA equivalent, in the sense that a small perturbation of a certain input is propagated forward through the system, and the corresponding deviation of all outputs is estimated. Thus, all the methods described below may be called forward propagation methods. They are effective when the sensitivity of all (or many) outputs with respect to one (or few) entries are desired... Brute-Force Approach. Equation () is solved for two sets of parameters α,..., α j,..., α m and α,..., ᾱ j,..., α m, and the obtained outputs are c(t) and c(t), respectively. One-sided difference approach: If ᾱ j = α j and α j = α j + ɛ the following is an approximation of the local sensitivity at the point α,..., α j,..., α m : c i (t) c i(t) c i (t) α j ɛ If the dependence c(α) is smooth enough, then this is a first order approximation of the sensitivity coefficient. Central difference approach: If α j = α j + ɛ and ᾱ j = α j ɛ the following is an approximation of the local sensitivity at the point α,..., α j,..., α m : c i (t) c i(t) c i (t) α j ɛ If the dependence c(α) is sufficiently smooth, then this is a second order approximation of the sensitivity coefficient. The Brute-Force approach requires only one (for one-sided differences) or two (for central differences) extra function evaluations for each independent variable with respect to which sensitivities are desired. The main drawback is that the accuracy of the method is hard to analyze. The smaller the perturbation ɛ, the lower the truncation error resulting from the omission of higher order terms (see the expansion of finite difference formulas in Taylor series), but the higher the loss-of-significance errors, resulting from subtracting two almost equal numbers. At the very best, the brute force approach results in a sensitivity approximation that has half the significant digits of f... Variational Equations. By differentiating () with respect to the vector of parameters we obtain the variational equations: () d dt c i(t). = P i (c) D i (c) c i D i c i, i =,..., n The fact that the sensitivities satisfy () can be proved rigorously, see for example []. The notation A stands for the sensitivity coefficients vector A α, and. = represents a vector (element-by-element) assignment. To obtain c i (t), one has to numerically integrate the large system obtained by appending together () and (). This method is usually referred as the direct approach.

5 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD The initial values c i (0) must be set properly. There are two main drawbacks of this approach: The generation of the variational equations requires significant extra effort; The integration of the large appended system may be very time consuming... Automatic Differentiation. Automatic differentiation techniques are based on the fact that any function ( regardless of its complexity ) is executed on a computer as a well-determined sequence of elementary operations like additions, multiplications and calls to elementary ( intrinsic ) functions such as sin, cos, etc. By repeatidly applying the chain rule: ( ) ( ) f(s) g(t) t f(g(t)) t=t 0 = s s=g(t 0) t=t0 t to the composition of these elementary operations one can compute, completely automatically, derivatives of f that are correct up to machine precision. According to how the chain rule is used to propagate derivatives through the computation, one can distinguish two approaches to AD: the forward and the reverse modes (see [], [] for a detailed discussion). The Forward Mode. Is similar to the way in which the chain rule of differential calculus is usually taught. At each computational stage derivatives of the intermediate variables with respect to input variables are computed. These derivatives are propagated forward through the computational stages. From now on we will refer to forward automatic differentiation as FAD. The Reverse Mode. Adjoint quantities - the derivatives of the final result with respect to intermediate variables - are computed at each step. To propagate adjoints, one has to be able to reverse the flow of a program, and remember or recompute any intermediate value that nonlinearly impacts the final result.. Applying automatic differentiation on ODE integrators. The numerical simulation of the chemical transformations consists in integrating (advancing in time) a system of coupled, stiff ordinary differential equations that models the chemical rate equations. It is of interest to ask how automatic differentiation can be used to obtain sensitivities of concentrations with respect to different parameters, given the rate equations and a numerical routine that solves them. The simplest approach would be to apply AD directly on the numerical integrator; we will call this the black box approach. A more refined technique, which necessitates the expert (user) intervention, would be to generate the sensitivity (variational) equations via automatic differentiation, then to integrate them using a user-defined technique, for example If x = x c i then c i (0) =, otherwise c i (0) = 0. Reffered throughout the paper as AD.

6 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA Concentration Solver Concentrations Rate Eqn Numerical Integrator ADIFOR AD Generated Code Sensitivities Rate Eqn Concentrations ADIFOR Sensitivity Eqn Numerical Integrator (DDM) Sensitivities Fig.. Alternative ways of using automatic differentiation for calculating chemical sensitivities. The black box approach (upper figure) is completely automatical, while the variational equation approach (lower figure) requires user intervention. employing the direct decoupled method. Figure gives a visual description of these two possibilities. In short, black box FAD computes the sensitivities of the numerical solution, while the variational approach gives a numerical solution to the sensitivity equations. The black box approach is simpler, while the variational equations approach is more flexible. In the next sections we will investigate both approaches... Black-box approach. Given the initial value problem () c = f(t, c, α), c(t 0 ) = c 0 one would like to numerically compute the solution in time c(t) and also to find the sensitivity of this solution with respect to the parameters α R m. Suppose for the sake of discussion that we solve () numerically with a one-step, first order consistent method, expressed in Henrici notation as: () c n+ = c n + h n Φ(t n, c n, c n+, α, h n ) where c k = c(t k ) = c(t 0 + i h i) and Φ is supposed to be smooth in all its arguments. The method is applied with a predefined selection of the stepsize h i (either using a

7 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD 7 constant step or a prescribed step for example, take smaller steps during sunrise and sundown intervals; it is essential that h does not depend on c, as is the case with inline step controllers, typical for all popular variable step-size codes). The consistency of the method implies that Φ(t, c, c, α, 0) = f(t, c, α) and hence, since Φ is supposed to be smooth in all its arguments we have: (7) lim Φ(t, c n, c n+, α, h) h 0. = lim Φ(t, c n, c n+, α, h) h 0. = Φ(t, c n, c n, α, 0). = f c (t, c n, α) c n + f α (t, c n, α) The sensitivities c = c/ α obey the variational equations: d dt c. = fc (t, c, α) c + f α (t, c, α). = Φ(t, c, c, α, 0) Forward automatic differentiation applied on () will generate: (8) c n+. = cn + h n Φ cn (t n, c n, c n+, α, h n ) c n +h n Φ cn+ (t n, c n, c n+, α, h n ) c n+ +h n Φ α (t n, c n, c n+, α, h n ) so c n+. = cn + h n (Φ cn + Φ cn+ )(t n, c n, c n, α, 0) c n + h n Φ α (t n, c n, c n, α, 0) + O(h n). = c n + h n d dt c n + O(h n) Hence by forward automatic differentiating () we obtain (9), a first order consistent method for solving the variational equation. The above remark leads us to the following conclusion: Black box automatic differentiation implicitly generates the sensitivity equations. More exactly, suppose we start with a code that solves () using a numerical method A. The time discretization A of the initial equation () is transformed by black box FAD into a time discretization of the variational equation (8). This represents a new integration method B. We say that B is the derivative of the method A. If the method B is convergent, then the resulting code will be able to consistently calculate sensitivities. Thus, the black box FAD is equivalent to the direct method, since the resulting code applies a numerical integrator (B) to the variational equations (8). The QSSA method belongs to the class studied here, namely order one, explicit, prescribed step methods. The above analysis can be applied to other methods widely used in atmospheric chemistry, e.g. the hybrid algorithm of Young and Boris (used with fixed step-size).

8 8 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA... Variable step size algorithms. If the algorithm uses an error controller that adjusts the stepsize based on local error estimates, then h n depends on c n and (9) becomes: c n+ = c n + h n Φ c (t n, c n, α, h n ) c n + h n Φ α (t n, c n, α, h n ) + (h n Φ h (t n, c n, α, h n ) + Φ(t n, c n, α, h n )) h n The last term, and the eventual stepsize rejections may create problems when the algorithm is automatically differentiated. In order to have the last term equal to zero one would need hφ h = Φ (which implies Φ = Ψ/h, contradicting consistency) or h = 0. This last condition is not satisfied in general by the variable step-size algorithms; consider for example the asymptotic step controller: h n = ( c ĉ h n tol h n = ( c ĉ h n tol ) p+ ) p+ +Const h n tol /p+ (c ĉ) ( c ĉ) c ĉ +Const h n c ĉ tol tol (p+)/(p+)... Implicit methods. If an implicit method is used for solving () then at each time step a nonlinear system of algebraic equations has to be solved. This is usually done by Picard or by simplified Newton iterations. Black box FAD will transform the nonlinear system in concentrations into a nonlinear system in concentrations and sensitivities, and will add to the iterative solution for concentrations an iterative solution for sensitivities. For example consider the fixed step-size method (9a) (9b) c n+ = c n + hφ(t, c n k,..., c n+, α, h) c n+. = cn + h i=k i= Φ cn i (t, c n k,..., c n+, α, h) c n i c n + hφ α (t, c n k,..., c n+, α, h) Both formulas (9a), (9b) are implicit since they involve Φ(..., c n+ ) and Φ c (c n+ ), respectively. The code generated by black box FAD will consist of an iterative solution of (9a) and (9a) coupled together. If (9a) is solved first, and the obtained value for c n+ is then used in (9b), this becomes a linear system in c n+ ; hence the sensitivities can be obtained with only one matrix decomposition (of I hφ cn+ for all α i ) and without any iterations (the Direct Decoupled Method from [9]). Thus, we may conclude that black box FAD is equivalent to the direct (coupled) method, with which it shares the disadvantage of extra computational effort.

9 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD 9 The convergence of the sensitivity iterations adds to the problems mentioned above. The aspects of derivative convergence are thoroughly examined in [0]; it is shown that, if the concentration iterations are convergent, under natural hypothesis, the new sensitivity iterations are also convergent.... One step methods. Let A be a one-step method consistent of order p; its local error has an asymptotic expansion of the form: c(t + h) c(t) h Φ(t, c(t), h) = By differentiating the above relation: c(t + h) c(t) h Φ(t, c(t), h) = N+ i=p+ N+ i=p+ d i (t, α) h i + O ( h N+) d i (t, α) h i + O ( h N+) which shows that, if the d i are smooth in α, the differentiated method B has the same order of consistency. Also, if the global error of the method satisfies then c(t 0 + nh) c n = N+ i=p+ c(t 0 + nh) c n Φ(t, c(t), h) = (b i (t, α) + β i ) h i + O ( h N+) N+ i=p+ (b i (t, α) + β i ) h i + O ( h N+) Thus if the initial method is convergent of order p and if the expansion coefficients b i and the perturbations β i are smooth in α, then the differentiated method converges with the same order. The above considerations show that although automatic differentiation produces derivatives that are exact up to the machine precision, the accuracy of the sensitivities computed by the black box FAD depends on the accuracy of the underlying numerical integration method (in particular depends on its order).... Linear Multistep methods. By differentiating the linear multistep method applied on the rate equation () one obtains the same method, applied on sensitivity equations (8): (0a) (0b) k α i c n+i = h i=0 k α i c n+i = h i=0 k β i f n+i i=0 k β i ((f c ) n+i c n+i + (f α ) n+i ) i=0 Hence, the following diagram commutes for multistep methods (provided that sensitivity iterations converge if the multistep method is implicit).

10 0 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA Kinetic Eqn MS Concentrations ADIFOR ADIFOR Variational Eqn MS Sensitivities.. Black box forward automatic differentiation of the QSSA method. As an illustration, we consider in detail the integration of () using the Quasi- Steady- State- Approximation (QSSA) technique (see []). This method solves () with the first order consistent formula: () c(t 0 + h) = e D0 h (c 0 D 0 P 0 ) + D 0 P 0 where () is applied on the typical integration interval [t 0, t 0 + h], c 0 = c(t 0 ), P 0 = P (c 0 ) and D 0 = D(c 0 ). Because of the diagonal form of D, () can be decomposed componentwise, and the implementation of the QSSA step looks like this: () call compute (in : t 0, α, c 0 ; out : P 0, D 0 ) do i =, n c i (t 0 + h) = e Di 0 h end do ( ) c 0,i P i 0 + P i D0 i 0 D0 i The subroutine compute calculates the production and destruction terms at t, c. From (), the FAD will generate the algorithm: call g compute (in : t 0, α, c 0, c 0 ; out : P 0, D 0, P 0, D 0 ) (a) (b) do i =, n c i (t 0 + h) = e Di 0 h ( c 0,i P i 0 D i 0 ) + P i 0 D i 0 c i (t 0 + h) =. ( h D0 i e Di 0 h c 0,i P 0 i ) D0 i ( +e Di 0 h c 0,i P 0 i D0 i + P 0 i D0 i ) (D0 i ) end do + P i 0 D i 0 P i 0 D i 0 (D i 0 )

11 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD Equation (b) is a numerical method applied to (). From (b) it is clear that: c(h) h=0 = c 0 d dh c i(t 0 + h) h=0 = D0 i D i 0 ( c 0,i P 0 i ) D0 i ( c 0 P i 0 D i 0 ) + P i 0 D i 0 (D i 0 ) = D i 0 c 0,i D i 0 c 0,i + P i 0 and by comparing this with () we conclude that (b) is an order consistent method applied to the variational equations.... The steady-state equations. Many codes use the steady-state approximation for the radical differential equations. More exactly, let c = [l, r] with l denoting the long-lived species and r the radical species and let Π(l, r), (l, r) be the production and destruction terms for radicals: dr(t) dt dr(t) dt = Π(l(t), r(t)) (l(t), r(t)) r Consider the radicals to vary so rapidly, that they are at steady state. 0 and Then () r(t) Π(l(t), r(t)) (l(t), r(t)) This algebraic equation is commonly solved by fixed-point (functional) iterations, keeping l(t) = l 0 = constant: do k =, No of iterations call radical (in : α, β, r k, l 0 ; out : Π k, k ) do i =, No of radicals end do i end do k r k+ i = Πk i k i where the superscript k refers to the iteration number. By forward automatic differentiation, this becomes: do k =, No of iterations call g radical (in : α, β, r k, l 0, β, r k, l 0 ; out : Π k, k, Π k, k ) do i =, No of radicals

12 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA (a) (b) r k+ i = r k+ i end do i end do k Π k i k i. = Πk i k i Πk i k i ( k i ) It is interesting to look at (b) in relation with (). Since the radicals are supposed to be at steady-state, the sensitivities r are constant in time and hence () becomes: () r i. = Π i i r i i i. = Π i i Π i i, i =,..., n i This reveals that the FAD generated (b) is a fixed point iteration to solve the nonlinear system (). For the conditions under which these iterations converge we refer again to [0].... Conclusions for automatically differentiated QSSA. Black box application of forward automatic differentiation on a fixed step-size QSSA algorithm () is equivalent to solving the variational equations () with the first order method given by the formula (b). If the steady state approximation is used for radicals, and the resulting nonlinear equations are solved by fixed point iterations, then forward automatic differentiation will result in an algorithm that uses the steady state assumption on the variational equation and solves the nonlinear equations for r by a fixed point scheme. We point out again here that the errors of the numerical scheme (b) will dominate those induced by the automatic differentiation process. Hence, it is reasonable to expect that the computed sensitivity coefficients are at most as accurate as the computed concentrations.. Sensitivity calculation via FAD-generated variational equations... General setting. As shown by our previous considerations, automatic differentiation implicitly generates the linearized equations (). To be more precise, let the rate equations be described by the subroutine: subroutine compute (in : t, α, c; out : cdot) where α are the parameters, c is the vector of concentrations and cdot = dc/dt at given input arguments. Forward automatic differentiation will generate: subroutine g compute (in : t, α, c, c; out : cdot, cdot) Under the assumptions that sensitivities obey () and that dc/dt is a smooth function of t and α the subroutine g compute completely describes () because: cdot = dc dt = d dt c.

13 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD It is therefore possible to combine the advantages of FAD with efficient numerical schemes if we firstly generate () via automatic differentiation, then solve the variational system using an integrator of choice. This approach should work: better than the black box automatic differentiation, which is in principle equivalent to the direct approach, with a fixed method for integrating the system; the hybrid approach allows the use of variable step-size algorithms and enables the decoupled integration of sensitivity equations ([9]); easier than the usual implemention of the direct (decoupled) method where the variational equations are derived either by hand or by using symbolic manipulation... Direct decoupled method with dedicated algorithms. Dedicated algorithms are explicit methods for the numerical solution of the rate equations () which make use of their special (production-destruction) form; examples of dedicated methods are QSSA, Young and Boris and Two-Step (see [9]). Looking at the variational equation () we remark that it is also formulated in production - destruction form: d dt c i(t) P i (c). = P i (c) D i c i, i =,..., n, where:. = P i (c) D i (c) c i, i =,..., n, D i (c) = D i (c), i =,..., n. Since dedicated integrators perform the computations in a componentwise manner, their use leads to a natural decoupling between the concentration and the sensitivity equations. Thus, we can extend the direct decoupled method of [9] to dedicated integrators. In the case of using QSSA-type methods, since their main computational load (besides function evaluation) consists of calculating the exponentials exp( D i t) and since D i (c) = D i (c), i =,..., n, the algorithm can be optimized, in the sense that the exponentials have to be evaluated only once per component per time step (and not once per sensitivity coefficient per time step).. Accuracy of different methods: numerical comparisons. In this subsection we display some numerical results obtained by integrating variational equations with Plain QSSA, Extrapolated QSSA and Symmetric QSSA methods (as described in []). We have employed VODE (see []) to accurately solve the system of ordinary differential equations, as well as the corresponding variational system. We consider the exact solution to be that obtained by integrating the variational system with VODE, rtol=0, atol=0 8. The experiments correspond to scenario, the free case.

14 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA relative error relative error time [hours] time [hours] Fig.. Relative errors in computed concentration C (dots) and in brute force C/ [NO] 0 (solid) for C = O (left) and C = OH (right). This illustrates the fact that the number of significant digits in the brute force sensitivity coefficient is at most half of the number of significant digits in the computed concentration Figure compares the relative errors in the computed concentration and the corresponding brute-force sensitivity coefficient / [NO] 0. The integration was done in double precision with VODE (rtol=0 ). Figure illustrates a point that we made earlier, namely that, for the brute force approach, the number of significant digits in the computed sensitivity coefficient is at most half of the number of significant digits in the value of the function (here, the value of the concentration c). 0 0 relative error relative error time [hours] time [hours] Fig.. Relative errors in [O ]/ [NO] 0 (left) and [NO]/ [NO] 0 (right) with brute - force approach (dots), directly differentiated QSSA algorithm (solid), and QSSA integrated variational equations (dash-dashed). This illustrates the accuracy of different methods. Figure compares the relative errors in the sensitivity coefficients / [NO] 0 computed by directly differentiating the QSSA code (solid lines), by integrating the variational equations with QSSA (step-size 0 seconds, dash-dashed line) and by bruteforce estimating them from the outputs of the QSSA code (step-size 0 seconds). This comparison illustrates the fact that the number of significant digits in the computed

15 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD sensitivity coefficients is given by the precision of the integration scheme (here QSSA) and not by the precision of automatic differentiation process (which is of the same order as machine precision). As expected, the brute force approach is the least accurate, while the integration of variational equations seems to be the right choice. The CPU timings corresponding to these numerical experiments are shown in Table. The calculation of the sensitivities of all species with respect to one parameter implies the calculation of 8 coefficients (since the model has 8 variable species); the calculation of the sensitivities of all species with respect to all initial values implies the calculation of 8*8 coefficients. Method No of sensitivity Normalized coefficients time QSSA concentrations only Direct FAD on QSSA Variational eqns with QSSA Variational eqns with Extrapolated QSSA Variational eqns with Symmetric QSSA Table Timings for different methods 7. Application of FAD to a comprehensive atmospheric chemical mechanism. The chemical mechanism used in this study is that presently used in the STEM-II regional scale transport/ chemistry/ removal model (see [7]). This mechanism consists of 8 chemical species and 78 gas phase reactions. The mechanism, based on the work of Lurmann et al. ([]) and Atkinson et al. ([]) is representative of those presently being used in the study of chemically perturbed environments. The mechanism represents the major features of the photochemical oxidant cycle in the troposphere and can be used to study the chemistry of both highly polluted (e.g., near urban centers) and remote environments. The photochemical oxydant cycle is driven by solar energy and involves nitrogen oxides, reactive hydrocarbons, sulphur oxides and water vapour. The chemistry also involves naturally occuring species as well as those produced by anthropogenic activities. Many of the chemical reaction rate coefficients vary with the intensity of solar radiation (photolysis rates), and thus follow a strong diurnal cycle. Others vary with temperature. To test the robustness of the above numerical algorithms, we have employed six different scenarios 7 (summarised in Table ). These conditions represent various chemical environments ranging from: low NO x oceanic boundary layer regions (Ma- The timings may depend on the size of the code and the amount of memory available. Results presented here were obtained on a HP-UX A 9000/7 workstation with 8 M RAM, using level of optimization. 7 These scenarios follow the IPCC (Intergovernmental Panel on Climate Change) photochemistry intercomparison.

16 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA Scenario Elements Units Marine Land Bio Free Plume Plume Altitude [Km] Temp [K] Pressure [mbar] Nitrogen [0 9 cm ] H O [ppb] H [ppb] H O [ppb] O [ppb] NO x [ppb] HNO [ppb] CO [ppb] CH [ppb] NMHC [ppb] 0 0 (ISOP) Table Initial Conditions for each of the six IPCC scenarios simulated. O conc [ ppb ] time [ hours ] Fig.. description) The variations of ozone under different IPCC scenarios (see Table for a detailed rine); high NO x continental boundary layer regions without (Land) and with isoprene (Bio); dry upper tropospheric regions (Free); biomass burning plumes without (Plume ) and with (Plume ) reactive hydrocarbon species. Further details are presented in Chapter 7 of the current WMO Ozone Assesment (see [8]). ADIFOR was used to calculate sensitivities of ozone with respect to initial conditions and reaction rate pa-

17 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD 7 HCHO HO conc [ ppb ] 0 0 conc [ ppb ] time [ hours ] time [ hours ] NO NO conc [ ppb ] 0 conc [ ppb ] time [ hours ] time [ hours ] HNO 0 0 HNO 0 0 conc [ ppb ] 0 0 conc [ ppb ] time [ hours ] time [ hours ] OH HO conc [ ppb ] conc [ ppb ] time [ hours ] time [ hours ] Fig.. Variation of the most important species under IPCC scenarios

18 8 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA Lumped sensitivity. Normalized d [O] / d [C]o Species number LUMPED Species number OZONE Species Sensitivity Species Sensit > 0 Species Sensit < 0 HNO.09E+00 O 8.8E-0 H O -.9E-0 O.98E+00 CH.0E-0 CO -.07E-0 CH.00E+00 HNO.89E-0 P RN.78E-0 RAO.88E+00 NO.9E-0 MRO -.08E-07 R O.0E+00 NO.7E-0 V RO -.8E-07 P RN.E+00 M AO.E-07 RAO -.807E-07 CRO.98E+00 KO.0E-07 M V KO -8.79E-08 M CRG.7E+00 M CO.008E-07 OH -7.00E-08 Fig.. Marine case, lumped sensitivities w.r.t. initial values (left) and sensitivities of ozone w.r.t. initial values (right). rameters. In the simulations of these cases the QSSA method with a fixed stepsize of 0 seconds was used. This algorithm is suited for direct automatic differentiation, and is easy to implement when solving (). Its use leads to results having - significant digits. The calculated ozone concentrations for the five cases are presented in Figure, and all other important species in Figure. In the marine boundary layer case, ozone is continuously destroyed throughout the day period. The land and bio conditions show initially ozone production, followed by a net slight destruction of ozone over the simulation period. In the dry free troposphere (Free) ozone values decrease very slowly. Both plume cases show a large net ozone production. The case (Plume-) without non-methane hydrocarbons (NMHC) shows a much slower net ozone production rate, and a distinct diurnal behavior. The Plume- case (with NMHC) shows a very rapid increase in ozone, followed by a period of slow ozone destruction. The calculated local sensitivities of ozone with respect to the initial conditions of each species for the Marine case are shown in Figure. Plotted are the normalized sensitivities at 0 hours of simulation. Also shown are the 8 largest (+) sensitivities (indicating ozone production) and (-) sensitivities 8. Under these conditions ozone 8 The species number list is presented in the appendix

19 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD 9 concentrations are most sensitive to the initial concentration of ozone ( as expected since this case has a net destruction of ozone). Ozone levels increase with increases in CH, NO x = NO + NO and HNO, species which both lead to the production of ozone and also help to modulate the HO concentrations which is the principal lose mechanism for ozone under these conditions. Note also that HNO is the principal source of NO x in this case since its initial condition is an order of magnitude higher than NO x. The largest negative sensitivity is that with respect to H O, which is the dominant source of HO radicals. Also shown are the lumped sensitivities. Lumped sensitivities can help describe the overall effect of a given perturbation. The lumped sensitivity of the system with respect to parameter α j is defined as: (7) L(α j ) = N ( ) ci (t) (α j ) i= where c i, i =,..., N are the concentrations of the component species. Since L(α j ), j =,..., m are functions of time, and since we are interested in the global effect of α j over the system, we employ the mean values of the lumped sensitivity coefficients over the selected time horizon: (8) L(α j ) = t L(α j ) dt t t t If the mean sensitivities: S j = L(α j ) N are far less then one, the system is considered stable with respect to the initial conditions (see [8]). Numerical experiments with the test problem showed that lumped sensitivities are dominated by ozone sensitivity. This may happen because O concentration is larger than other variable species. To obtain a more accurate description of the global response of the system with respect to perturbations of initial conditions, we employ the lumped normalized sensitivities: ˆL(α j ) = N ( αj c i (t) c ) i(t) (9) (α j ) where c i, i =,..., N are the concentrations of the component species. i= The lumped coefficients are thought of as measures of the global influence of one parameter over the whole system. These quantities are a bit more difficult to interpret. A large value can arise from a few very large individual sensitivities or from many

20 0 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA species being sensitive to changes in one individual parameter (as is the case for the radical species). One drawback is that, when a parameter has a large influence over a specific or small number of species, the lumped coefficient may be large, although, from a chemical standpoint, the global influence is negligible. As an example, look at Table. The large lumped sensitivity associated with DMS can be explained by a strong influence of DMS initial concentration over itself, although the effect of this parameter on important species is negligible. Results for all the cases are summarized in Tables and. The land, bio and free cases are quite similar. One notable difference is the bio case where isoprene is shown to have a large negative sensitivity. This highly reactive species is an important source of peroxyl radicals. The Plume- and Plume- cases both show large net ozone production and thus behave much differently than the previous cases. In the Plume- case, ozone increases with increases in O, CO, CH, and H O. Under high NO x conditions these species are involved in reactions which increase the peoroxyl radical pool, which in turn leads to net ozone production. Ozone decreases with increases in NO x, because in the absence of NMHC these species scavenge the free radicals and shorten the chain propagation reactions. When sufficient N M HC are present then ozone production is larger, and increases in NO x lead to increases in ozone. The importance of reactive hydrocarbons appears both in the production and destruction of ozone. At the time shown in Table, ozone is in a period of net ozone destruction. Here ozone is being destroyed by reaction with hyroperoxyl radicals. As shown in Figure, ozone production is very rapid during the first day of the simulation. In this period ozone production is driven by N M HC reactions involving alkenes, aldehydes, isoporene and aromatics. After this initial period, those less reactive species which supply peroxyl radicals contribute to ozone destruction (e.g., aldehyde, and aromatics and alkanes). NO x, which both produces ozone and scavenges peroxyl radicals, shows positive sensitivities. The lumped sensitivities are much higher indicating the higher overall reactivity of the system, and the importance of the NMHC s. The amount of ozone produced in an air mass is a complex function of the absolute amounts of NO x, the relative amounts (the value of NMHC/NO x ) and the meteorological conditions (solar actinic flux, temperature, water vapor, etc.). A net ozone production efficiency e N has been defined by Lin et. al. (see []): e N = O NO y where e N represents the net number of ozone molecules produced per molecule of NO y consumed. When the above equation is evaluated using observations or model derived estimates of ozone, it represents a lower limit since ozone is deposited at the earth s surface. This metric can be used to help characterize the modeled ozone production efficiencies. The relationships between model calculated O and NO z are presented in Figure. The quantity NO z is defined as: NO z = NO y NO x

21 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD = P RN + P RN + P RP N + HNO + HONO + P AN + T P AN + R N + RAN + RAN + N O + HNO + NO + MP AN + IP AN + INO + MAN + MV N and is a metric which reduces variations arising from differences in the age of the air masses being compared ( see [7], []). This ozone production efficiency is simply a local sensitivity. This efficiency was calculated using ADIFOR for each of the studied cases. The results are shown in Figure 7. The highest ozone production efficiencies occur for the marine case followed by the land, bio and free conditions. For these cases e N ranges from to 0. The plume with NMHC shows a value of, while the plume without NMHC has a very small ozone production efficiency. These values can be compared to those measured in the eastern United States during the summer. Olsyzyna et al. ([]) report a value of (0 for NO y ) at Harvard Forrest, MA, while Trainer et al. ([7]) report an average value of 8. at several rural sites. ADIFOR was also used to calculate the sensitivity of ozone to variations in the reaction rate constants. The results for the individual and lumped sensitivities are shown in Tables and respectively. For the marine case the largest (+) sensitivities occur for the photolysis reaction of NO and HNO and consumption reactions of HO (i.e., the HO + HO reaction and the NO + HO type reactions). These reactions consume the peroxyl radical which by reaction with O destroys ozone. The largest (-) sensitivities occur for the major ozone destruction reactions (O + hν and O + HO ). Again the land, bio and free cases show similar behavior. The bio case shows a much higher reactivity as measured by the magnitudes of the lumped sensitivities. The plume cases show a different behavior. The case without N M HC (Plume-) shows that ozone is most positively sensitive to the reaction rate constants for the NO photolysis rate, the NO reaction with HO, CO oxidation by OH and ozone photolysis. The largest negative sensitivities occur for the NO + OH and O + NO reactions. The Plume- case shows the importance of NMHC reaction rate constants. For example, ozone has a positive sensitivity with respect to the reaction rate constant for the ethene and alkene oxidation by OH, aldehyde photolysis, and reactions involving P AN (i.e., P AN MCO + NO ). Ozone decreases with increases in reaction rate constants for the MCO +NO reaction, and other reactions similar to the Plume- case. 8. Conclusions. ADIFOR.0 has been succesfully used in the sensitivity analysis of a comprehensive tropospheric chemistry model. Automatic differentiation appears to be a valuable tool for sensitivity analysis of atmospheric chemistry models. In this paper we focused solely on the chemical equations. However the method applies to to the coupled transport/ chemistry problems as well. We are presently applying this technique to the STEM-II model ([7]). A valuable aspect of employing automatic differentiation for sensitivity analysis

22 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA absolute d ozone / d NOz time [hours] Fig. 7. Absolute sensitivities of ozone with respect to initial NO z concentration. The variation in time is shown for different IPCC scenarios. studies is that the atmospheric chemistry/ transport/ removal models are permanently subject to modifications and improvements. For routinely performing sensitivity analysis this means that, whenever a modification is performed in the model, the corresponding adjustment be made in the variational equations. Since the slightest mistake in the generation of variational equations could lead to useless results, one needs to thoroughly check for their correctness. Both the issues of easily generating the sensitivity equations and making sure they are error free can be directly and succesfully addressed by the use of automatic differentiation.

23 SENSITIVITY ANALYSIS FOR ATMOSPHERIC CHEMISTRY VIA AD O Marine Land Bio Free Plume Plume O 8.8E-0.E-0.0E-0 9.E-0.9E-0.E-0 CH.E-0.E-0 8.E-0 9.7E E E-0 CO -.0E-0.E-0.0E-0 -.0E-0 0.E+00.8E-0 HNO.8E-0.8E-0.00E-0.7E-0 9.0E-0.E-0 NO.E E-0.0E-0.E-0-7.8E-0.E-0 NO.E-0.97E-0.09E-0.E-0 -.7E-0.0E-0 HO -.E-0-7.E E-0-7.E-0 9.0E-0 -.0E-0 ISOP E E-0 ETHE E-0 ALD E-0 ALKE E-0 AROM E-0 ALKA E-0 C H E-0 Table Normalized sensitivities of O with respect to initial values (at the end of the fifth day); displayed are the values of modulus greater than E-0. REFERENCES [] H. Amann. Ordinary Differential Equations: An Introduction to Nonlinear Analysis. Walter de Gruyter, 990. [] R.D. Atkinson, D.L. Baulch, R.A. Cox, R.F.JR. Hampson, J.A. Kerr, and J. Troe. Evaluated kinetic and photochemical data for atmospheric chemistry. International Journal of Chemical Kinetics, : 90, 989. [] Ch. Bischof, A. Carle, G. Corliss, A. Griewank, and P. Hovland. ADIFOR generating derivative codes from FORTRAN programs. Technical report, Mathematics and Computer Science Division, Argonne National Laboratory, Argonne, Illinois, 99. [] Ch. Bischof, A. Carle, P. Khademi, and A. Mauer. The ADIFOR.0 system for the automatic differentiation of FORTRAN77 programs. Technical report, Mathematics and Computer Science Division, Argonne National Laboratory, Argonne, Illinois, 99. [] P.N. Brown, G.D. Byrne, and A.C. Hindmarsh. VODE: A Variable Step ODE Solver. SIAM J. Sci. Stat. Comput., 0:08 0, 989. [] D. G. Cacuci. Sensitivity theory for nonlinear systems. I. Nonlinear functional analysis approach. J. Math. Phys., :79 80, 98. [7] G.R. Carmichael, L.K. Peters, and T. Kitada. A second generation model for regional-scale transport/ chemistry/ deposition. Atmospheric environment, 0:7 88, 98. [8] Y. S. Cho. Ph.d. thesis. The University of Iowa, 98. [9] A. M. Dunker. The decoupled direct method for calculating sensitivity coefficients in chemical kinetics. Journal of Chemical Physics, 8:8, 98. [0] A. Griewank, C. Bischof, G. Corliss, A. Carle, and K. Williamson. Derivative convergence for iterative equation solvers. Optimization methods and software, :, 99. [] E. Hesstvedt, O. Hov, and I. Isaacsen. Quasi-steady-state-approximation in air pollution modelling: comparison of two numerical schemes for oxidant prediction. Int. J. Chem. Kinet., 0:97 99, 978. [] L.O. Jay, A. Sandu, F.A. Potra, and G.R. Carmichael. Improved QSSA methods for atmospheric chemistry integration. SIAM Journal on Scientific Computing, 8:8 0, 997. [] X. Lin, M. Trainer, and S. Liu. On the nonlinearity of tropospheric ozone production. Journal of Geophysical Research, 9:,879,888, 988. [] F.W. Lurmann, A.C. Loyd, and R. Atkinson. A chemical mechanism for use in long-range

24 A. SANDU,G. R. CARMICHAEL, AND F. A. POTRA O Marine Land Bio Free Plume Plume HNO.0E E O.9E+00.77E+00.0E+0.E+00.E+00 - CH.0E+00.E E+00.E+00.9E+00 - CO.9E+00.8E+00.08E+0.7E+00.79E+00.00E+0 RAO.8E+00.70E+00.E+00.E R O.0E+00.9E+00 -.E PRN.E+00.E+00 -.E CRO.E MCRG.E NO -.E+00.E+00.E+00.9E+00.9E+0 NO -.E+00.9E+00.E+00.0E+0.0E+0 C H -.9E E+00 - ISOP E E+00 H O - -.E+00 -.E+00 - DMS E+00.E+00 CHO E+00 - ALKE E+00 ALD E+00 AROM E+00 C H E+00 ALKA E+00 Table Lumped sensitivities with respect to initial values (at the end of the fifth day); displayed are the values of modulus greater than E-0. transport/acid deposition computer modeling. Journal of Geophysical Research, 9:0,90 0,9, 98. [] I.M. Navon and U. Muller. FESW - A finite element FORTRAN IV program for solving the shallow water equations. Advances in engineering software, :77 8, 970. [] K. Olszyna, E. Bailey, R. Simonaites, and J. Meagher. O and NO y relationships at a rural site. Journal of Geophysical Research, 99:,7,, 99. [7] D. Parrish, J. Holloway, M. Trainer, P. Murphy, G. Forbes, and F. Fehsenfeld. Export of north american ozone pollution to the north atlantic ocean. Science, 9: 9, 99. [8] M. Prather. Intercomparison of tropospheric chemistry/ transport models. Scientific assesment of ozone depletion, World meteorological organization, 99. [9] J. Verwer and D. Simpson. Explicit Methods for Stiff Odes from Atmospheric Chemistry. Applied Numerical Mathematics, 8: 0, 99. [0] P. Werbos. Applications of advances in nonlinear sensitivity analysis. System modelling and optimization, Springer-Verlag:7 777, 98.

Reduced Atmospheric Chemistry Models by Sensitivity Matrix Approach

Reduced Atmospheric Chemistry Models by Sensitivity Matrix Approach Reduced Atmospheric Chemistry Models by Sensitivity Matrix Approach Short Communication Adrian Sandu Department of Computer Science, Michigan Technological University, Houghton, MI 49931. E-mail: asandu@mtu.edu.

More information

Tropospheric OH chemistry

Tropospheric OH chemistry Tropospheric OH chemistry CO Oxidation mechanism: CO + OH CO 2 + H, H + O 2 + M HO 2 + M, HO 2 + NO OH + NO 2 NO 2 + hν (+O 2 ) NO + O 3 Initiation step Propagation Net: CO + 2 O 2 CO 2 + O 3 HO 2 + HO

More information

The Chemical Kinetics Time Step a detailed lecture. Andrew Conley ACOM Division

The Chemical Kinetics Time Step a detailed lecture. Andrew Conley ACOM Division The Chemical Kinetics Time Step a detailed lecture Andrew Conley ACOM Division Simulation Time Step Deep convection Shallow convection Stratiform tend (sedimentation, detrain, cloud fraction, microphysics)

More information

8.2 Tropospheric ozone

8.2 Tropospheric ozone 8.2 Tropospheric ozone Prev Chapter 8. Ozone Next 8.2 Tropospheric ozone Tropospheric ozone is only about 10% of the total amount of ozone contained in a vertical column in the atmosphere. However, this

More information

Chapter 6 - Ordinary Differential Equations

Chapter 6 - Ordinary Differential Equations Chapter 6 - Ordinary Differential Equations 7.1 Solving Initial-Value Problems In this chapter, we will be interested in the solution of ordinary differential equations. Ordinary differential equations

More information

PROBLEMS Sources of CO Sources of tropospheric ozone

PROBLEMS Sources of CO Sources of tropospheric ozone 220 PROBLEMS 11. 1 Sources of CO The two principal sources of CO to the atmosphere are oxidation of CH 4 and combustion. Mean rate constants for oxidation of CH 4 and CO by OH in the troposphere are k

More information

A New Mechanism for Regional Atmospheric Chemistry Modelling. A contribution to subproject CMD. W.R. Stockwell', F Kirchner^ M. Kuhn' and S.

A New Mechanism for Regional Atmospheric Chemistry Modelling. A contribution to subproject CMD. W.R. Stockwell', F Kirchner^ M. Kuhn' and S. A New Mechanism for Regional Atmospheric Chemistry Modelling A contribution to subproject CMD W.R. Stockwell', F Kirchner^ M. Kuhn' and S. Seefeld* *Fraunhofer Institute for Atmospheric Environmental Research

More information

Chemical Kinetics of HC Combustion

Chemical Kinetics of HC Combustion Spark Ignition Engine Combustion MAK65E Chemical Kinetics of HC Combustion Prof.Dr. Cem Soruşbay Istanbul Technical University Chemical Kinetics of HC Combustion Introduction Elementary reactions Multi-step

More information

Atmospheric Environment

Atmospheric Environment Atmospheric Environment 44 (2010) 4426e4431 Contents lists available at ScienceDirect Atmospheric Environment journal homepage: www.elsevier.com/locate/atmosenv An adaptive reduction algorithm for efficient

More information

Organic Compounds - Formation Fate and Impact on Troposphere

Organic Compounds - Formation Fate and Impact on Troposphere Organic Compounds - Formation Fate and Impact on Troposphere i.gensch@fz-juelich.de 2 / 20 Organic Compounds - Formation Fate and Impact on Troposphere i.gensch@fz-juelich.de 2 / 20 Definitions VOC: organic

More information

Spatial Reduction Algorithm for Atmospheric Chemical Transport Models

Spatial Reduction Algorithm for Atmospheric Chemical Transport Models Spatial Reduction Algorithm for Atmospheric Chemical Transport Models Y. Rastigejev, M. P. Brenner and D. J. Jacob Division of Engineering and Applied Sciences, Harvard University Submitted to Proceedings

More information

Electronic supplementary information to Heterogeneous OH oxidation. of biomass burning organic aerosol surrogate compounds: Assessment

Electronic supplementary information to Heterogeneous OH oxidation. of biomass burning organic aerosol surrogate compounds: Assessment Electronic supplementary information to Heterogeneous OH oxidation of biomass burning organic aerosol surrogate compounds: Assessment of volatilisation products and the role of OH concentration on the

More information

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

2005 UPDATES TO THE CARBON BOND MECHANISM: CB05

2005 UPDATES TO THE CARBON BOND MECHANISM: CB05 2005 UPDATES TO THE CARBON BOND MECHANISM: CB05 Gary Z. Whitten, Smog Reyes Greg Yarwood, ENVIRON smogreyes@yahoo.com International Conference on Chemical Mechanisms December 6, 2006 Ackowledgements EPA:

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 9 Initial Value Problems for Ordinary Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign

More information

consideration, is indispensable. Due to the great number of restarts, one for each split-step time interval, it is particularly important to use integ

consideration, is indispensable. Due to the great number of restarts, one for each split-step time interval, it is particularly important to use integ Gauss-Seidel Iteration for Sti ODEs from Chemical Kinetics J.G. Verwer CWI P.O. Box 94079, 1090 GB Amsterdam, The Netherlands Abstract A simple Gauss-Seidel technique is proposed which exploits the special

More information

CHM 5423 Atmospheric Chemistry Notes on reactions of organics in the troposphere (Chapter 5)

CHM 5423 Atmospheric Chemistry Notes on reactions of organics in the troposphere (Chapter 5) CHM 5423 Atmospheric Chemistry Notes on reactions of organics in the troposphere (Chapter 5) 5.1 Introduction In general, the lifetime of a molecule in the troposphere is governed by a variet of processes.

More information

Ordinary differential equations - Initial value problems

Ordinary differential equations - Initial value problems Education has produced a vast population able to read but unable to distinguish what is worth reading. G.M. TREVELYAN Chapter 6 Ordinary differential equations - Initial value problems In this chapter

More information

The Regional Atmospheric Chemistry Mechanism, version 2 (RACM2)

The Regional Atmospheric Chemistry Mechanism, version 2 (RACM2) The Regional Atmospheric Chemistry Mechanism, version 2 (RACM2) William R. Stockwell 1,2 and Wendy S. Goliff 2 1 Department of Chemistry, Howard University 2 Division of Atmospheric Sciences, Desert Research

More information

WORKSHOP Saint Denis La Plaine, November Mechanism Reduction: Methodologies and Examples

WORKSHOP Saint Denis La Plaine, November Mechanism Reduction: Methodologies and Examples SAFe and Efficient hydrocarbon oxidation processes by KINetics and Explosion expertise and development of computational process engineering tools Project No. EVG1-CT-2002-00072 WORKSHOP Saint Denis La

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

Asymptotic Structure of Rich Methane-Air Flames

Asymptotic Structure of Rich Methane-Air Flames Asymptotic Structure of Rich Methane-Air Flames K. SESHADRI* Center for Energy and Combustion Research, Department of Mechanical and Aerospace Engineering, University of California at San Diego, La Jolla,

More information

Abstract. 1 Introduction

Abstract. 1 Introduction The influence of cloud chemistry on the budget of photo-oxidants G. Mauersberger Brandenberg Technical University Cottbus, Rudower Chausse 5, D-12489 Berlin, Germany Abstract The RADM II gas-phase system

More information

Computational Aspects of Data Assimilation for Aerosol Dynamics

Computational Aspects of Data Assimilation for Aerosol Dynamics Computational Aspects of Data Assimilation for Aerosol Dynamics A. Sandu 1, W. Liao 1, G.R. Carmichael 2, D. Henze 3, J.H. Seinfeld 3, T. Chai 2, and D. Daescu 4 1 Department of Computer Science Virginia

More information

Matrix Assembly in FEA

Matrix Assembly in FEA Matrix Assembly in FEA 1 In Chapter 2, we spoke about how the global matrix equations are assembled in the finite element method. We now want to revisit that discussion and add some details. For example,

More information

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9 Lecture Notes to Accompany Scientific Computing An Introductory Survey Second Edition by Michael T. Heath Chapter 9 Initial Value Problems for Ordinary Differential Equations Copyright c 2001. Reproduction

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations Professor Dr. E F Toro Laboratory of Applied Mathematics University of Trento, Italy eleuterio.toro@unitn.it http://www.ing.unitn.it/toro September 19, 2014 1 / 55 Motivation

More information

Review of the SAPRC-16 Chemical Mechanism and Comparison with the Regional Atmospheric Chemistry Mechanism, Version-2

Review of the SAPRC-16 Chemical Mechanism and Comparison with the Regional Atmospheric Chemistry Mechanism, Version-2 VOC O 3 NO NO NO 2 O 3 NO 2 Review of the SAPRC-16 Chemical Mechanism and Comparison with the Regional Atmospheric Chemistry Mechanism, Version-2 NO 2 William R. Stockwell a, Emily Saunders b, Rosa Fitzgerald

More information

The modeling of tropospheric oxidants (ozone and the hydroxyl

The modeling of tropospheric oxidants (ozone and the hydroxyl Spatial reduction algorithm for atmospheric chemical transport models Y. Rastigejev, M. P. Brenner*, and D. J. Jacob School of Engineering and Applied Sciences, Harvard University, Cambridge, MA 2139 Communicated

More information

1.07 A FOUR MODEL INTERCOMPARISON CONCERNING CHEMICAL MECHANISMS AND NUMERICAL INTEGRATION METHODS

1.07 A FOUR MODEL INTERCOMPARISON CONCERNING CHEMICAL MECHANISMS AND NUMERICAL INTEGRATION METHODS 1.7 A FOUR MODEL INTERCOMPARISON CONCERNING CHEMICAL MECHANISMS AND NUMERICAL INTEGRATION METHODS Bedogni M. 1, Carnevale C. 2, Pertot C. 3, Volta M. 2 1 Mobility and Environmental Ag. of Milan, Milan,

More information

7.2 NORTHEAST OXIDANT AND PARTICLE STUDY (NEOPS): PRELIMINARY RESULTS FROM THE CENTERTON, NEW JERSEY, FIELD SITE

7.2 NORTHEAST OXIDANT AND PARTICLE STUDY (NEOPS): PRELIMINARY RESULTS FROM THE CENTERTON, NEW JERSEY, FIELD SITE 7.2 NORTHEAST OXIDANT AND PARTICLE STUDY (NEOPS): PRELIMINARY RESULTS FROM THE CENTERTON, NEW JERSEY, FIELD SITE Nancy A. Marley* and Jeffrey S. Gaffney Environmental Research Division Argonne National

More information

On Stationary state, also called steady state. Lifetimes and spatial scales of variability

On Stationary state, also called steady state. Lifetimes and spatial scales of variability On sources and sinks ATOC 3500/CHEM 3151 Week 5-6 Additional Notes February 16/18, 2016 On lifetimes, variability, and models On Stationary state, also called steady state Lifetimes and spatial scales

More information

Ordinary differential equation II

Ordinary differential equation II Ordinary Differential Equations ISC-5315 1 Ordinary differential equation II 1 Some Basic Methods 1.1 Backward Euler method (implicit method) The algorithm looks like this: y n = y n 1 + hf n (1) In contrast

More information

An Atmospheric Chemistry Module for Modeling Toxic Industrial Chemicals (TICs) in SCIPUFF

An Atmospheric Chemistry Module for Modeling Toxic Industrial Chemicals (TICs) in SCIPUFF An Atmospheric Chemistry Module for Modeling Toxic Industrial Chemicals (TICs) in SCIPUFF Douglas S Burns, Veeradej Chynwat, Jeffrey J Piotrowski, Kia Tavares, and Floyd Wiseman ENSCO, Inc. Science and

More information

Richarson Extrapolation for Runge-Kutta Methods

Richarson Extrapolation for Runge-Kutta Methods Richarson Extrapolation for Runge-Kutta Methods Zahari Zlatevᵃ, Ivan Dimovᵇ and Krassimir Georgievᵇ ᵃ Department of Environmental Science, Aarhus University, Frederiksborgvej 399, P. O. 358, 4000 Roskilde,

More information

A comparison of the Bader Deuflhard and the Cash Karp Runge Kutta integrators for the GRI-MECH 3.0 model based on the chemical kinetics code Kintecus

A comparison of the Bader Deuflhard and the Cash Karp Runge Kutta integrators for the GRI-MECH 3.0 model based on the chemical kinetics code Kintecus 1368 A comparison of the Bader Deuflhard and the Cash Karp Runge Kutta integrators for the GRI-MECH 3.0 model based on the chemical inetics code Kintecus James C. Ianni Vast Technologies Development, Inc.,

More information

Abstract The Kinetic PreProcessor KPP was extended to generate the building blocks needed for the direct and adjoint sensitivity analysis of chemical

Abstract The Kinetic PreProcessor KPP was extended to generate the building blocks needed for the direct and adjoint sensitivity analysis of chemical Direct and Adjoint Sensitivity Analysis of Chemical Kinetic Systems with KPP: II Numerical Validation and Applications Dacian N. Daescu Institute for Mathematics and its Applications, University of Minnesota,

More information

Improvement and Sensitivity Analysis of the Atmospheric Chemistry Module for Modeling TICs in SCIPUFF

Improvement and Sensitivity Analysis of the Atmospheric Chemistry Module for Modeling TICs in SCIPUFF Improvement and Sensitivity Analysis of the Atmospheric Chemistry Module for Modeling TICs in SCIPUFF Douglas S Burns, Veeradej Chynwat, William Moore, Jeffrey J Piotrowski, and Floyd Wiseman ENSCO, Inc.

More information

ATM 507 Lecture 5. Text reading Chapter 4 Problem Set #2 due Sept. 20 Today s topics Photochemistry and Photostationary State Relation

ATM 507 Lecture 5. Text reading Chapter 4 Problem Set #2 due Sept. 20 Today s topics Photochemistry and Photostationary State Relation ATM 507 Lecture 5 Text reading Chapter 4 Problem Set #2 due Sept. 20 Today s topics Photochemistry and Photostationary State Relation Beer-Lambert Law (for the absorption of light) Used to describe the

More information

Total Energy Singular Vectors for Atmospheric Chemical Transport Models

Total Energy Singular Vectors for Atmospheric Chemical Transport Models Total Energy Singular Vectors for Atmospheric Chemical Transport Models Wenyuan Liao and Adrian Sandu Department of Computer Science, Virginia Polytechnic Institute and State University, Blacksburg, VA

More information

O3 concentration h 0.01

O3 concentration h 0.01 CS COMPUTER SCIENCE TECHNICAL REPORT Direct and Adjoint Sensitivity Analysis of Chemical Kinetic Systems with KPP: II Numerical Validation and Applications D. D aescu, A. Sandu, and G.R. Carmichael CSTR--

More information

Chapter 2 Finite Element Formulations

Chapter 2 Finite Element Formulations Chapter 2 Finite Element Formulations The governing equations for problems solved by the finite element method are typically formulated by partial differential equations in their original form. These are

More information

Derivative Based vs. Derivative Free Optimization Methods for Nonlinear Optimum Experimental Design

Derivative Based vs. Derivative Free Optimization Methods for Nonlinear Optimum Experimental Design Derivative Based vs. Derivative Free Optimization Methods for Nonlinear Optimum Experimental Design Stefan Körkel 1, Huiqin Qu 2, Gerd Rücker 3, and Sebastian Sager 1 1 Interdisciplinary Center for Scientific

More information

Lecture 13: Gas Phase Organic- NO x + UV Reactions II

Lecture 13: Gas Phase Organic- NO x + UV Reactions II Lecture 13: Gas Phase rganic- N x + UV Reactions II Required Reading: FP&P Chapter 6 (except as noted next) Additional Reading: S&P Chapter 5 Catching-Up Reading: Jacob Chapters 11 & 12 (free online) Atmospheric

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

Influence of Biogenic VOCs on Photooxidant Formation: Simulation Experiments in EUPHORE and Comparison with Model Calculations

Influence of Biogenic VOCs on Photooxidant Formation: Simulation Experiments in EUPHORE and Comparison with Model Calculations Introduction Influence of Biogenic VOCs on Photooxidant Formation: Simulation Experiments in EUPHORE and Comparison with Model Calculations Fraunhofer Institut Atmosphärische Umweltforschung, IFU Kreuzeckbahnstr.

More information

CHAPTER 12 Numerical Solution of Differential Equations

CHAPTER 12 Numerical Solution of Differential Equations CHAPTER 12 Numerical Solution of Differential Equations We have considered numerical solution procedures for two kinds of equations: In chapter 10 the unknown was a real number; in chapter 6 the unknown

More information

Lecture 18 Chain reactions Nikolai Nikolaevic Semenov , Nobel 1956

Lecture 18 Chain reactions Nikolai Nikolaevic Semenov , Nobel 1956 Lecture 18 Chain reactions Nikolai Nikolaevic Semenov 1896-1986, Nobel 1956 Chain reactions are examples of complex reactions, with complex rate expressions. In a chain reaction, the intermediate produced

More information

Solving Ordinary Differential equations

Solving Ordinary Differential equations Solving Ordinary Differential equations Taylor methods can be used to build explicit methods with higher order of convergence than Euler s method. The main difficult of these methods is the computation

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

2. Sketch a plot of R vs. z. Comment on the shape. Explain physically why R(z) has a maximum in the atmospheric column.

2. Sketch a plot of R vs. z. Comment on the shape. Explain physically why R(z) has a maximum in the atmospheric column. 190 PROBLEMS 10. 1 Shape of the ozone layer Consider a beam of solar radiation of wavelength λ propagating downward in the vertical direction with an actinic flux I at the top of the atmosphere. Assume

More information

Laminar Premixed Flames: Flame Structure

Laminar Premixed Flames: Flame Structure Laminar Premixed Flames: Flame Structure Combustion Summer School 2018 Prof. Dr.-Ing. Heinz Pitsch Course Overview Part I: Fundamentals and Laminar Flames Introduction Fundamentals and mass balances of

More information

NUMERICAL INTEGRATION OF CONSTRAINED MULTI-BODY DYNAMICAL SYSTEMS USING 5 T H ORDER EXACT ANALYTIC CONTINUATION ALGORITHM

NUMERICAL INTEGRATION OF CONSTRAINED MULTI-BODY DYNAMICAL SYSTEMS USING 5 T H ORDER EXACT ANALYTIC CONTINUATION ALGORITHM (Preprint) AAS 12-638 NUMERICAL INTEGRATION OF CONSTRAINED MULTI-BODY DYNAMICAL SYSTEMS USING 5 T H ORDER EXACT ANALYTIC CONTINUATION ALGORITHM Ahmad Bani Younes, and James Turner Many numerical integration

More information

EVALUATION OF ATMOSPHERIC PROCESSES FOR OZONE FORMATION FROM VEHICLE EMISSIONS

EVALUATION OF ATMOSPHERIC PROCESSES FOR OZONE FORMATION FROM VEHICLE EMISSIONS EVALUATION OF ATMOSPHERIC PROCESSES FOR OZONE FORMATION FROM VEHICLE EMISSIONS by WILLIAM P. L. CARTER STATEWIDE AIR POLLUTION RESEARCH CENTER, and COLLEGE OF ENGINEERING CENTER FOR ENVIRONMENTAL RESEARCH

More information

CONTENTS 1 MEASURES OF ATMOSPHERIC COMPOSITION

CONTENTS 1 MEASURES OF ATMOSPHERIC COMPOSITION i CONTENTS 1 MEASURES OF ATMOSPHERIC COMPOSITION 1 1.1 MIXING RATIO 1 1.2 NUMBER DENSITY 2 1.3 PARTIAL PRESSURE 6 PROBLEMS 10 1.1 Fog formation 10 1.2 Phase partitioning of water in cloud 10 1.3 The ozone

More information

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

1. Introduction to Chemical Kinetics

1. Introduction to Chemical Kinetics 1. Introduction to Chemical Kinetics objectives of chemical kinetics 1) Determine empirical rate laws H 2 + I 2 2HI How does the concentration of H 2, I 2, and HI change with time? 2) Determine the mechanism

More information

PART I Lecture Notes on Numerical Solution of Root Finding Problems MATH 435

PART I Lecture Notes on Numerical Solution of Root Finding Problems MATH 435 PART I Lecture Notes on Numerical Solution of Root Finding Problems MATH 435 Professor Biswa Nath Datta Department of Mathematical Sciences Northern Illinois University DeKalb, IL. 60115 USA E mail: dattab@math.niu.edu

More information

EFFECTS OF PROPENE ON THE REMEDIATION OF NOx FROM DIESEL EXHAUSTS*

EFFECTS OF PROPENE ON THE REMEDIATION OF NOx FROM DIESEL EXHAUSTS* EFFECTS OF PROPENE ON THE REMEDIATION OF NOx FROM DIESEL EXHAUSTS* Rajesh Dorai and Mark J. Kushner University of Illinois Department of Electrical and Computer Engineering Urbana, IL 6181 Email : Mark

More information

Lecture 6 Asymptotic Structure for Four-Step Premixed Stoichiometric Methane Flames

Lecture 6 Asymptotic Structure for Four-Step Premixed Stoichiometric Methane Flames Lecture 6 Asymptotic Structure for Four-Step Premixed Stoichiometric Methane Flames 6.-1 Previous lecture: Asymptotic description of premixed flames based on an assumed one-step reaction. basic understanding

More information

High Performance Nonlinear Solvers

High Performance Nonlinear Solvers What is a nonlinear system? High Performance Nonlinear Solvers Michael McCourt Division Argonne National Laboratory IIT Meshfree Seminar September 19, 2011 Every nonlinear system of equations can be described

More information

10. Stratospheric chemistry. Daniel J. Jacob, Atmospheric Chemistry, Harvard University, Spring 2017

10. Stratospheric chemistry. Daniel J. Jacob, Atmospheric Chemistry, Harvard University, Spring 2017 10. Stratospheric chemistry Daniel J. Jacob, Atmospheric Chemistry, Harvard University, Spring 2017 The ozone layer Dobson unit: physical thickness (0.01 mm) of ozone layer if compressed to 1 atm, 0 o

More information

CHAPTER 8. AEROSOLS 8.1 SOURCES AND SINKS OF AEROSOLS

CHAPTER 8. AEROSOLS 8.1 SOURCES AND SINKS OF AEROSOLS 1 CHAPTER 8 AEROSOLS Aerosols in the atmosphere have several important environmental effects They are a respiratory health hazard at the high concentrations found in urban environments They scatter and

More information

The Finite Difference Method

The Finite Difference Method Chapter 5. The Finite Difference Method This chapter derives the finite difference equations that are used in the conduction analyses in the next chapter and the techniques that are used to overcome computational

More information

CHAPTER 10: Numerical Methods for DAEs

CHAPTER 10: Numerical Methods for DAEs CHAPTER 10: Numerical Methods for DAEs Numerical approaches for the solution of DAEs divide roughly into two classes: 1. direct discretization 2. reformulation (index reduction) plus discretization Direct

More information

COMPARISON OF TWO METHODS TO SOLVE PRESSURES IN SMALL VOLUMES IN REAL-TIME SIMULATION OF A MOBILE DIRECTIONAL CONTROL VALVE

COMPARISON OF TWO METHODS TO SOLVE PRESSURES IN SMALL VOLUMES IN REAL-TIME SIMULATION OF A MOBILE DIRECTIONAL CONTROL VALVE COMPARISON OF TWO METHODS TO SOLVE PRESSURES IN SMALL VOLUMES IN REAL-TIME SIMULATION OF A MOBILE DIRECTIONAL CONTROL VALVE Rafael ÅMAN*, Heikki HANDROOS*, Pasi KORKEALAAKSO** and Asko ROUVINEN** * Laboratory

More information

TEST 1 APCH 211 (2012) Review, Solutions & Feedback

TEST 1 APCH 211 (2012) Review, Solutions & Feedback TEST 1 APCH 11 (01) Review, Solutions & Feedback Question 1 What is the concentration of nitrogen in the atmosphere (0 C and 1 atm) in g/l? N in the atmosphere ~ 78% Gas concentration unit s means that

More information

COMBUSTION CHEMISTRY COMBUSTION AND FUELS

COMBUSTION CHEMISTRY COMBUSTION AND FUELS COMBUSTION CHEMISTRY CHEMICAL REACTION AND THE RATE OF REACTION General chemical reaction αa + βb = γc + δd A and B are substracts and C and are products, α, β, γ and δ are stoichiometric coefficients.

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

Module III: Partial differential equations and optimization

Module III: Partial differential equations and optimization Module III: Partial differential equations and optimization Martin Berggren Department of Information Technology Uppsala University Optimization for differential equations Content Martin Berggren (UU)

More information

The Milne error estimator for stiff problems

The Milne error estimator for stiff problems 13 R. Tshelametse / SAJPAM. Volume 4 (2009) 13-28 The Milne error estimator for stiff problems Ronald Tshelametse Department of Mathematics University of Botswana Private Bag 0022 Gaborone, Botswana. E-mail

More information

Variational assimilation Practical considerations. Amos S. Lawless

Variational assimilation Practical considerations. Amos S. Lawless Variational assimilation Practical considerations Amos S. Lawless a.s.lawless@reading.ac.uk 4D-Var problem ] [ ] [ 2 2 min i i i n i i T i i i b T b h h J y R y B,,, n i i i i f subject to Minimization

More information

Supplement of Observation of isoprene hydroxynitrates in the southeastern United States and implications for the fate of NO x

Supplement of Observation of isoprene hydroxynitrates in the southeastern United States and implications for the fate of NO x Supplement of Atmos. Chem. Phys., 15, 11257 11272, 2015 http://www.atmos-chem-phys.net/15/11257/2015/ doi:10.5194/acp-15-11257-2015-supplement Author(s) 2015. CC Attribution 3.0 License. Supplement of

More information

Ozone production in the upper troposphere and the influence of aircraft during SONEX: approach of NO x -saturated conditions

Ozone production in the upper troposphere and the influence of aircraft during SONEX: approach of NO x -saturated conditions Ozone production in the upper troposphere and the influence of aircraft during SONEX: approach of NO x -saturated conditions The Harvard community has made this article openly available. Please share how

More information

Exponentially Fitted Error Correction Methods for Solving Initial Value Problems

Exponentially Fitted Error Correction Methods for Solving Initial Value Problems KYUNGPOOK Math. J. 52(2012), 167-177 http://dx.doi.org/10.5666/kmj.2012.52.2.167 Exponentially Fitted Error Correction Methods for Solving Initial Value Problems Sangdong Kim and Philsu Kim Department

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

Compute the behavior of reality even if it is impossible to observe the processes (for example a black hole in astrophysics).

Compute the behavior of reality even if it is impossible to observe the processes (for example a black hole in astrophysics). 1 Introduction Read sections 1.1, 1.2.1 1.2.4, 1.2.6, 1.3.8, 1.3.9, 1.4. Review questions 1.1 1.6, 1.12 1.21, 1.37. The subject of Scientific Computing is to simulate the reality. Simulation is the representation

More information

Kinetics Mechanisms (2008-rev) Review and Examples

Kinetics Mechanisms (2008-rev) Review and Examples II 25 Kinetics Mechanisms (2008-rev) Review and Examples Mechanism: series of elementary steps (uni-, bimolecular) that combine to give observed rate law elementary step - reaction order lie stoichiometry

More information

One-Dimensional Models

One-Dimensional Models One-Dimensional Models GCC Summer School, 2005 Banff, Alberta Dylan Jones Department of Physics University of Toronto Observations and Models Observations Models Envelope of M-O variance Criteria for model

More information

16.7 Multistep, Multivalue, and Predictor-Corrector Methods

16.7 Multistep, Multivalue, and Predictor-Corrector Methods 740 Chapter 16. Integration of Ordinary Differential Equations 16.7 Multistep, Multivalue, and Predictor-Corrector Methods The terms multistepand multivaluedescribe two different ways of implementing essentially

More information

CHAPTER 1: Functions

CHAPTER 1: Functions CHAPTER 1: Functions 1.1: Functions 1.2: Graphs of Functions 1.3: Basic Graphs and Symmetry 1.4: Transformations 1.5: Piecewise-Defined Functions; Limits and Continuity in Calculus 1.6: Combining Functions

More information

Kinetics Mechanisms (2012) Examples Atkins Ch 7 Tinoco Ch.7 (p ), Engel Ch , Ch

Kinetics Mechanisms (2012) Examples Atkins Ch 7 Tinoco Ch.7 (p ), Engel Ch , Ch II 3 Kinetics Mechanisms (01) Examples Atins Ch 7 Tinoco Ch.7 (p.341-354), Engel Ch 5.5-10, Ch 6.1-3 Recall penicillin example basic chemistry, open ring N O R + H O O O We saw observed rate law: 1 st

More information

On the Diagonal Approximation of Full Matrices

On the Diagonal Approximation of Full Matrices On the Diagonal Approximation of Full Matrices Walter M. Lioen CWI P.O. Box 94079, 090 GB Amsterdam, The Netherlands ABSTRACT In this paper the construction of diagonal matrices, in some

More information

Numerical Methods. King Saud University

Numerical Methods. King Saud University Numerical Methods King Saud University Aims In this lecture, we will... find the approximate solutions of derivative (first- and second-order) and antiderivative (definite integral only). Numerical Differentiation

More information

Ozone Formation in Coastal Urban Atmospheres: The Role of Anthropogenic Sources of Chlorine

Ozone Formation in Coastal Urban Atmospheres: The Role of Anthropogenic Sources of Chlorine Ozone Formation in Coastal Urban Atmospheres: The Role of Anthropogenic Sources of Chlorine, Sarah Oldfield, Charles B. Mullins, David T. Allen In this communication, we present experimental results from

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

Structure-activity relationships for the development of MCM/GECKOA mechanisms

Structure-activity relationships for the development of MCM/GECKOA mechanisms Atmospheric Chemical Mechanisms, Davis, December 2018 Structure-activity relationships for the development of MCM/GECKOA mechanisms Acknowledgement: Bernard Aumont Richard Valorso, Marie Camredon LISA

More information

Linearity Analysis for Automatic Differentiation

Linearity Analysis for Automatic Differentiation Linearity Analysis for Automatic Differentiation Michelle Mills Strout 1 and Paul Hovland 2 1 Colorado State University, Fort Collins, CO 80523 2 Argonne National Laboratory, Argonne, IL 60439 Abstract.

More information

CHAPTER 1. MEASURES OF ATMOSPHERIC COMPOSITION

CHAPTER 1. MEASURES OF ATMOSPHERIC COMPOSITION 1 CHAPTER 1. MEASURES OF ATMOSPHERIC COMPOSITION The objective of atmospheric chemistry is to understand the factors that control the concentrations of chemical species in the atmosphere. In this book

More information

M-RICh v0.5 MATLAB Rate Integrator for Chemical equations

M-RICh v0.5 MATLAB Rate Integrator for Chemical equations M-RICh v0.5 MATLAB Rate Integrator for Chemical equations Abstract: Accurately simulating the chemical conditions within a reactor tests both the stability and accuracy of a numerical scheme. M-RICh is

More information

Module 6 : Reaction Kinetics and Dynamics Lecture 28 : Elementary Reactions and Reaction Mechanisms

Module 6 : Reaction Kinetics and Dynamics Lecture 28 : Elementary Reactions and Reaction Mechanisms Module 6 : Reaction Kinetics and Dynamics Lecture 28 : Elementary Reactions and Reaction Mechanisms Objectives In this Lecture you will learn to do the following Define what is an elementary reaction.

More information

Modeling and Experimentation: Compound Pendulum

Modeling and Experimentation: Compound Pendulum Modeling and Experimentation: Compound Pendulum Prof. R.G. Longoria Department of Mechanical Engineering The University of Texas at Austin Fall 2014 Overview This lab focuses on developing a mathematical

More information

Efficient Hessian Calculation using Automatic Differentiation

Efficient Hessian Calculation using Automatic Differentiation 25th AIAA Applied Aerodynamics Conference, 25-28 June 2007, Miami Efficient Hessian Calculation using Automatic Differentiation Devendra P. Ghate and Michael B. Giles Oxford University Computing Laboratory,

More information

CHM 5423 Atmospheric Chemistry Notes on kinetics (Chapter 4)

CHM 5423 Atmospheric Chemistry Notes on kinetics (Chapter 4) CHM 5423 Atmospheric Chemistry Notes on kinetics (Chapter 4) Introduction A mechanism is one or a series of elementary reactions that convert reactants into products or otherwise model the chemistry of

More information

Numerical integration and differentiation. Unit IV. Numerical Integration and Differentiation. Plan of attack. Numerical integration.

Numerical integration and differentiation. Unit IV. Numerical Integration and Differentiation. Plan of attack. Numerical integration. Unit IV Numerical Integration and Differentiation Numerical integration and differentiation quadrature classical formulas for equally spaced nodes improper integrals Gaussian quadrature and orthogonal

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Partial differential equations arise in a number of physical problems, such as fluid flow, heat transfer, solid mechanics and biological processes. These

More information

Designing Information Devices and Systems I Spring 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way

Designing Information Devices and Systems I Spring 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way EECS 16A Designing Information Devices and Systems I Spring 018 Lecture Notes Note 1 1.1 Introduction to Linear Algebra the EECS Way In this note, we will teach the basics of linear algebra and relate

More information

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way EECS 16A Designing Information Devices and Systems I Fall 018 Lecture Notes Note 1 1.1 Introduction to Linear Algebra the EECS Way In this note, we will teach the basics of linear algebra and relate it

More information

Representations of Sp(6,R) and SU(3) carried by homogeneous polynomials

Representations of Sp(6,R) and SU(3) carried by homogeneous polynomials Representations of Sp(6,R) and SU(3) carried by homogeneous polynomials Govindan Rangarajan a) Department of Mathematics and Centre for Theoretical Studies, Indian Institute of Science, Bangalore 560 012,

More information

Quadratic SDIRK pair for treating chemical reaction problems.

Quadratic SDIRK pair for treating chemical reaction problems. Quadratic SDIRK pair for treating chemical reaction problems. Ch. Tsitouras TEI of Chalkis, Dept. of Applied Sciences, GR 34400 Psahna, Greece. I. Th. Famelis TEI of Athens, Dept. of Mathematics, GR 12210

More information