Introduction There has been recently anintense interest in verification and validation of large-scale simulations and in modeling uncertainty [,, ]. I

Size: px
Start display at page:

Download "Introduction There has been recently anintense interest in verification and validation of large-scale simulations and in modeling uncertainty [,, ]. I"

Transcription

1 Modeling Uncertainty in Flow Simulations via Polynomial Chaos Dongbin Xiu and George Em Karniadakis Λ Division of Applied Mathematics Brown University Providence, RI 9 Submitted to Journal of Computational Physics February 8, Abstract We present a new algorithm based on Polynomial Chaos in order to model the input uncertainty and its propagation in incompressible flow simulations. Specifically, the stochastic input is represented spectrally by employing the Wiener-Hermite polynomials. Randomness is thus expressed as a new continuous variable, in addition to the space-time domain. A standard Galerkin projection is performed and the resulting set of coupled equations is then solved to obtain the solution for each random mode. We implement the method in the context of the spectral/hp element method, which maintains control of the numerical error while its spectral trial basis is from the same Askey family of polynomials as the Polynomial Chaos. The algorithm is applied to micro-channel flows with random wall boundary conditions, and to external flows with random freestream. Both Gaussian and non-gaussian inputs are considered, and the results are in good agreement with exact solutions and Monte Carlo simulations. The Polynomial Chaos based stochastic simulation, although more expensive than the corresponding deterministic simulation, it generates all the solution statistics in a single run. Compared with the Monte Carlo simulation, which requires at least thousands of runs to obtain accurate statistics, the Polynomial Chaos expansion promises a substantial speed-up (at least one thousand in the current simulations), and thus it is a very effective approach in modeling uncertainty propagation in flow simulations. Λ Corresponding author, gk@cfm.brown.edu

2 Introduction There has been recently anintense interest in verification and validation of large-scale simulations and in modeling uncertainty [,, ]. In simulations, just like in the experiments, we often question the accuracy of the results and we construct aposteriori error bounds, but the new objective is to model uncertainty from the beginning of the simulation and not simply as an afterthought. Numerical accuracy and error control have been employed in simulations for some time now, at least for the modern discretizations, e.g. [, ]. However, there is still an uncertainty component associated with the physical problem, and specifically with such diverse factors as constitutive laws, boundary and initial conditions, transport coefficients, source and interaction terms, geometric irregularities (e.g. roughness), etc.. Most of the research effort in CFD research sofarhas been in developing efficient algorithms for different applications, assuming an ideal input with precisely defined computational domains. With the field reaching now some degree of maturity, we naturally pose the more general question of how to model uncertainty and stochastic input, and how to formulate algorithms in order for the simulation output to reflect accurately the propagation of uncertainty. To this end, the Monte Carlo approach can be employed but it is computationally expensive and it is only used as the last resort. The sensitivity method is an alternative more economical approach, based on moments of samples, but it is less robust and it depends strongly on the modeling assumptions [6]. There are other more suitable methods for physical applications, and there has already been good progress in other fields, most notably in seismology and structural mechanics. Anumber of papers and books have been devoted to this subject, e.g. [7],[8], [9],[], [],[],[],[]. The most popular technique for modeling stochastic engineering systems is the perturbation method where all stochastic quantities are expanded around their mean via a Taylor series. This approach, however, is limited to small perturbations and does not readily provide information on high-order statistics of the response. Another approach is based on expanding the inverse of the stochastic operator in a Neumann series, but this too is limited to small fluctuations, and even combinations with the Monte Carlo method seem to result in computationally prohibitive algorithms for complex systems []. A more effective approach pioneered by Ghanem and Spanos [] in the context of finite elements for solid mechanics is based on a spectral representation of the uncertainty. This allows high-order representation, not just first-order as in most perturbation-based methods, at high computational efficiency. It is based on the original ideas of Wiener (98) on homogeneous chaos [6, 7] and the Hermite polynomials. The classical Grad's method of moments for solutions of Boltzmann equation is based on Hermite polynomial expansions

3 as well [8]. The effectiveness of Hermite expansions was also recognized by Chorin in his early work [9], who employed Wiener-Hermite series to substantially improve both accuracy and computational efficiency of Monte Carlo algorithms. However, the limitation of prematurely truncated Wiener-Hermite expansions, especially in applications of turbulence [], has also been recognized. The spectral representation of the uncertainty is based on a trial basis Ψ( ) where denotes the random event. For example, the vorticity (! in two-dimensions) has the following finite-dimensional representation!(x;t; )= PX! i (x;t)ψ i (ο( )): i= Here! i (x;t) represents the deteministic part and can be interpreted as a scale (i) of vorticity fluctuation. The random trial basis is expressed in terms of multi-dimensional Hermite polynomials in powers of the random variable ο( ), which defines a specific probability distribution; for example, ο( ) may be a Gaussian function. The polynomial trial basis constructed in this way has been termed Polynomial Chaos (PC) by Wiener. It is a functional, as it is a function of ο which is a function of the random parameter [; ]. The theory of orthogonal functionals plays a key role in the algorithms that we develop in this work. Note that the Monte Carlo algorithm is a subcase of the above representation corresponding to the collocation procedure where the test basis is Ψ i ( ) =ffi( i ); with ffi the Kronecker delta function, and i referring to an isolated random event. For convergence, the Monte Carlo method requires a great number of such events as it ignores interactions between the various scales unlike the Galerkin representation. In this work we propose a Polynomial Chaos (PC) expansion procedure to represent the uncertainty of the input in flow simulations. The algorithms we develop are general but in this paper we concentrate on modeling the uncertainty associated with boundary conditions. This situation is encountered, for example, in micro-channel flows [] but also in classical flows such, e.g. the freestream of flow past bluff bodies. We assume that the velocity at the boundaries is described by amean value and a random perturbation with certain propability distribution function (PDF). This distribution can be assumed to have a known analytical form, e.g. Gaussian or lognormal distribution, or it can be a measured distribution provided in tabulated form. The PC procedure can handle both Gaussian and non- Gaussian representations, although for certain distributions there may exist a better representation than the original Wiener-Hermite polynomial basis. To this end, we can replace the Wiener-Hermite expansions by the best spectral polynomials of the Askey family [] that match specific distribution functions. For example, the appropriate set for

4 Poisson distributions is the Charlier polynomials, for Gamma distributions the Laugerre polynomials, for binomial distributions the Krawtchouk polynomials, for the beta kernel the Jacobi polynomials, etc. This can be appreciated by the fact that the orthogonality weights of these polynomials match the probability measure of the corresponding polynomials, and the same relationship exists of course for the Hermite polynomials and the Gaussian distribution. The work we present in this paper is based on the pioneering work in solid mechanics of Ghanem & Spanos [] but applied here to incompressible Navier-Stokes equations. In addition, we employ the spectral/hp element method in order to obtain a better control of the numerical error []. Our approach leads to homogeneous representations as the mixed inner products required in the random and spatial disretizations are all spectral polynomials. In particular, for certain distributions, e.g. beta kernels the corresponding Askey polynomial for the Wiener expansion is the Jacobi polynomial, which is exactly the same as the trial basis employed in the spectral/hp element method []. In the next section we review the PC expansion, and in section we address its implementation details as applied to Navier-Stokes equations. In section we present computational results for Gaussian and lognormal distributions, and we compare with analytical stochastic solutions of Navier-Stokes we have obtained as well as with corresponding Monte Carlo simulations. We conclude the paper with a discussion on possible extensions and applications of the stochastic spectral/hp element method. We also include two appendices that explain how to generate partially correlated Gaussian fields and how to approximate the lognormal distribution that may be useful to CFD readers. Representation of Random Processes In this section we briefly review the PC expansion along with the Karhunen-Loeve (KL) expansion, another classical technique for representating random processes. The KL expansion will be used to represent the known stochastic fields, e.g. the input. In the following analysis, we will use the symbol ο to denote the standard Gaussian random variable, i.e., Gaussian random variable with zero mean and unit variance.. Polynomial Chaos Expansion The PC expansion was first proposed by Wiener [6]. According to the theorem by Cameron & Martin [], it can be used to approximate any functional in L (C) andconverges to the functional in the L (C) sense. Therefore, PC provides a means for expanding second-order random processes in terms of orthogonal polynomials. Second-order random processes are processes with finite variance, and this applies to all viscous flow processes. Thus, a secondorder random process X( ), viewed as a function of the independent random variable, can be represented in the

5 form X( ) = a H X i = X a i H (ο i ( )) i X i = i = X Xi Xi i = i = i = a ii H (ο i ( );ο i ( )) a ii i H (ο i ( );ο i ( );ο i ( )) + ; () where H n (ο i ;:::;ο in ) denotes the polynomial chaos of order n in the variables (ο i ;:::;ο in ). The above equation is the discrete version of the original Wiener-Hermite expansion, where the continuous integrals are replaced by summations. The general expression of the polynomials is given n H n (ο i ;:::;ο in )=e οt ο ( ) n e οt ο ; in where ο denotes the vector consisting of n random variables (ο i ;:::;ο in ). For notational convenience, equation () can be rewritten as X( ) = X j= ^a j Ψ j (ο); () where there is a one-to-one correspondence between the functions H n (ο i ;:::;ο in )andψ j (ο). The Polynomial Chaos forms a complete orthogonal basis in the L space of random variables, i.e., < Ψ i Ψ j >=< Ψ i >ffi ij; () where ffi ij is the Kronecker delta and < ; > denotes the ensemble average. This is the inner product in the Hilbert space of random variables <f(ο)g(ο) >= Z f(ο)g(ο)w (ο)dο: () and it is justified by the Cameron & Martin theorem []. The weighting function is W (ο) = p (ß) n e οt ο : (6) What distinguishes the Wiener-Hermite expansion from many other possible complete sets of expansions is that the polynomials here are orthononormal with respect to the weighting function W (ο) that has the form of a n- dimensional independent Gaussian probability distribution with unit variance. For example, the one-dimensional

6 (n = ) polynomials are: Ψ =; Ψ = ο; Ψ = ο ; Ψ = ο ο; ::: (7) The orthogonality condition takes the specific form < Ψ i Ψ j >=< Ψ i >ffi ij =(i!)ffi ij : (8). Karhunen-Loeve Expansion The Karhunen-Loeve (KL) expansion [] is another way of representing a random process. It is based on the spectral expansion of the covariance function of the process. Let us denote the process by h(x; ) and its covariance function by R hh (x; y), where x and y are the spatial or temporal coordinates. By definition, the covariance function is real, symmetric and positive definite. All eigenfunctions are mutually orthogonal and form a complete set spanning the function space to which h(x; ) belongs. The KL expansion then takes the following form: h(x; )= μ h(x)+ X p i ffi i (x)ο i ( ); (9) i= where μ h(x) denotes themeanoftherandom process, and ο i ( ) forms a set of orthogonal random variables. Also, ffi i (x) and i are the set of eigenfunctions and eigenvalues of the covariance function, respectively, i.e., Z R hh (x; y)ffi i (y)dy = i ffi i (x): () If the random process itself h(x; ) is a Gaussian process, then the random variables ο i form an orthonormal Gaussian vector. Among many possible decompositions of a random process, the KL expansion is optimal in the sense that the mean-square error resulting from a finite representation of the process is minimized. Its use, however, is limited as the covariance function of the solution process is often not known apriori. Nevertheless, the KL expansion still provides an effective means of representation of the input random processes when the covariance structure is known. In this paper we will employ the KL procedure to represent the stochastic boundary conditions in the case of Gaussian distributions. For non-gaussian distributions we will employ Polynomial Chaos representations directly. Polynomial Chaos Expansion for Navier-Stokes Equations In this section we discuss the solution procedure for solving the stochastic Navier-Stokes equations by PC expansion. The randomness in the solution can be introduced through boundary conditions, initial conditions, forcing, etc. 6

7 . Governing Equations We employ the incompressible Navier-Stokes equations r u = +(u r)u = rπ+re r u; () where Π is the pressure and Re the Reynolds number. All flow quantities, i.e., velocity and pressure are considered stochastic processes. A random dimension, denoted by the parameter, is introduced in addition to the spatialtemporal dimensions (x;t), thus u = u(x;t; ); Π=Π(x;t; ) () We then apply the Polynomial Chaos expansion () to these quantities to obtain u(x;t; ) = PX i= u i (x;t)ψ i ( ); Π(x;t; ) = PX i= Π i (x;t)ψ i ( ); () where we have replaced the infinite summation in () by a finite term summation. The total number of expansion terms, (P + ), depends on the number of random dimensions (n) and the highest order of the polynomials chaos (p) []: P =+ px s= Y s (n + r): () s! The most important aspect of the above expansion is that all random processes have been decomposed into a set of deterministic functions in the spatial-temporal variables multiplying random coefficients that are independent of these variables. Substituting () into Navier-Stokes equations (() and ()) and noting that the partial derivatives are taken in physical space and thus they commute with the operations in random space, we obtain the following equations PX i (x;t) Ψ i PX PX i= j= PX i= r= r u i (x;t)ψ i = ; (6) [(u i r)u j )]Ψ i Ψ j = PX i= rπ i (x;t)ψ i + ν PX i= r u i Ψ i : (7) We then project the above equations onto the random space spanned by the basis polynomials fψ i g by taking the inner product of above equation with each basis.by taking < ; Ψ k > and utilizing the orthogonality condition (), we obtain the following set of equations: 7

8 For each k + < Ψ k > PX PX i= j= r u k = ; (8) e ijk [(u i r)u j )] = rπ k + νr u k ; (9) where e ijk =< Ψ i Ψ j Ψ k >. Together with < Ψ i >, these coefficients can be determined analytically from the definition of Ψ i and equation (). This set of equations consists of (P + ) system of Navier-Stokes equations for each random mode coupled through the convection term. The solution associated with k = term represents the mean of the random solution. The solution corresponding to the first-order polynomial chaos, i.e., the k = ;:::;n terms where n is the dimension of random space, represents the Gaussian part of the solution. The rest of the solution terms represent the nonlinear interactions between the mean and each Gaussian part of the solution and are non-gaussian.. Numerical Formulation.. Temporal Discretization We employ the semi-implicit high-order fractional step method, which for the standard deterministic Navier-Stokes equations (() and ()) has the form [6]: ^u P J q= ff qu n q t ^u ^u t fl u n+ ^u t = JX q= fi q [(u r)u] n q ; () = rπ n+ ; () = Re r u n+ ; () where J is order of accuracy in time and ff; fi and fl are the coefficients of the integration weights. A pressure Poisson equation is obtained by enforcing the discrete divergence-free condition r u n+ = r Π n+ = t r ^u; () with the appropriate pressure boundary condition = n ^u + Re r! n+λ ; () where n is the outward unit normal vector and! = r u is the vorticity. The method is stiffly-stable and achieves third-order accuracy in time; the coefficients for the integration weights can be found in []. In order to discretize the stochastic Navier-Stokes equations, we apply the same approach to the coupled set of equations (8) and (9): 8

9 For each k =;:::;P, ^u k P J q= ff qu n q k t ^u k ^u k t fl u n+ k ^u k t = < Ψ k > JX q= fi q P X PX i= j= n q e ijk (u i r)u j ; () = rπ n+ k ; (6) = Re r u n+ k : (7) The discrete divergence-free condition for each moder u n+ k each pressure mode with appropriate pressure boundary condition derived similarly as in [6] = results in a set of consistent Poisson equations for r Π n+ k = t r ^u k; k =;:::;P; = n ^u Λ k + Re r! n+ k ; k =;:::;P; (9) where n is the outward unit normal vector along the boundary, and! k = r u k is the vorticity for each random mode... Spatial Discretization Spatial discretization can be carried out by any method, but here we employ the spectral/hp element method in order to have better control of the numerical error []. In addition, the all-spectral discretization in space and along the random direction leads to homogeneous inner products, which in turn result in more efficient ways of inverting the algebraic systems. In particular, the spatial discretization is based on Jacobi polynomials on triangles or quadrilaterals in two-dimensions, and tetrahedra, hexahedra or prisms in three-dimensions.. Post-Processing The coefficients in the expansion of the solution process () are obtained after solving equations () to (9). We then obtain the analytical form (in random space) of the solution process. It is possible to preform a number of analytical operations on the stochastic solution in order to carry out a sensitivity analysis. Specifically, the mean solution is contained in the expansion term with index of zero. The second-moment, i.e., the covariance function is given by R uu (x ;t ; x ;t ) = < u(x ;t ) u(x ;t ); u(x ;t ) u(x ;t ) > = PX ui (x ;t )u i (x ;t ) < Ψ >Λ i : () i= 9

10 Note that the summation starts from index (i = )instead of to exclude the mean, and that the orthogonality of the PC basis fψ i g has been used in deriving the above equation. The variance of the solution, also called the `mean-square' value, is obtained as Var(u(x;t)) =< X P u(x;t) u(x;t) >= u i (x;t) < Ψ >Λ i ; () i= and the root-mean-square (rms) is simply the square root of the variance. Similar expressions can be obtained for the pressure field. Stochastic Flow Simulations In this section we presentnumerical results of the Polynomial Chaos solution to the Navier-Stokes equations. We first consider a micro-channel flow where there is uncertainty associated with the wall boundary conditions. Subsequently, we simulate a laminar flow past a circular cylinder with uncertain freestream. We model the uncertainty in the boundary conditions both as Gaussian and as lognormal distributions in order to evaluate the convergence of the PC method. In both cases we employ a two-dimensional Polynomial Chaos expansion (n = ) with polynomial order up to p = ; these polynomial coefficients are listed in table. Index p, Order of k th Polynomial Chaos k Polynomial Chaos Ψ k p = p = ο ο p = ο ο ο 6 p = ο ο ο 7 ο ο ο 8 ο ο ο 9 ο ο p = ο 6ο + ο ο ο ο ο ο ο ο + ο ο ο ο ο 6ο + Table : Polynomial terms for two-dimensional Polynomial Chaos.. Micro-channel Flow: Gaussian Input We consider a micro-channel flow as shown in figure. In micro-flows the no-slip boundary condition is not always valid and appropriate slip boundary conditions should be used []. For gas flows Maxwell's boundary condition on

11 velocity slip or its high-order variants are appropriate at least in the slip flow regime. However, for liquids there is no existing models for the molecule layering observed in molecular dynamics simulations [7]. Also, the effect of roughness complicates further the validity or not of the no-slip boundary condition. Here we model such uncertainty at the boundary by assuming that u =+r where r is a random variable. y= u=u y x F=ν y=- u=u Figure : Schematic of the domain for micro-channel pressure-driven flow. The domain (see figure ) has dimensions such thaty [ ; ] and x [ ; ]. The pressure gradient, acting like a driving force, equals to twice the kinematic viscosity, and thus for a no-slip condition a parabolic profile is a solution with centerline velocity equals to unity. Assuming that the two walls are moving with constant velocities u and u, then the exact solution is so it is a superposition of the Poiseuille and two Couette type flows... Fully-Correlated Random Boundary Conditions u(x; y) =( y )+ y u + +y u () Let us now assume that the boundary conditions are random and spatially uniform, i.e., u = ffο and u = ff ο ; where ο and ο are two independent standard Gaussian random variables with zero mean and unit variance and ff, ff are the standard deviations of u and u, respectively. In this case, the exact solution of equation () still

12 applies and thus u(x; y) =( y )+ y ff ο + +y ff ο () It can be seen from table that the solution consists of the parabolic mean u and only the first two random modes u and u, linearly distributed across the channel. We will use this solution to validate the stochastic Navier-Stokes solver. u u u..7. u.. u, u y Figure : Solution profile across the channel with uniform Gaussian boundary conditions. Figure shows the solution profile across the channel. The solution is obtained by setting ff = : and ff =:. Atwo-dimensional PC expansion is used (n =)withpolynomial Chaos of order p =. The numerical results correctly obtain the distribution profiles of the mean, the first and the second random modes. If p>is employed, all higher-order random modes are identically zero... Partially-Correlated Random Boundary Conditions Next we consider the case of non-uniform random boundary conditions, i.e. the boundary points are only partiallycorrelated and thus the random contribution to the boundary condition varies along the walls. The boundary conditions are assumed to be Gaussian random processes with correlation function in the form C(x ;x )=e jx x j b ; ()

13 6 where b is the correlation length. This correlation function has been employed extensively to model processes in a variety of fields and its use can be justified on theorectical grounds [8]. Given the exponential form of the correlation function, the Karhunen-Loeve expansion of equation (9) can be used to decompose the input random process. The corresponding eigenvalue problem of equation () can be solved analytically. The eigenvalues are: and the eigenfunctions are: b n = ; n =; ;::: () +b! n f n (x) = 8 >< >: cos(! q n x) a+ sin(!na)!n sin(! n x) q a sin(!na)!n if n is odd, if n is even, where [ a; a] is the size of the domain, and! n is determined by ρ b! n tan(! n a)= if n is odd,! n + b tan(! na) = if n is even. The details of the derivations can be found in []. If the correlation function is not in the exponential form as in equation () and the eigenvalue problem cannot be solved analytically, the correlation function can be constructed numerically and a standard eigenvalue solver can be employed. (6) E- -.8E E E-.87E- -.87E E- -9.9E Figure : Deviation of mean solution from a parabolic profile in micro-channel flow with partially-correlated random boundary conditions at the lower wall; Upper: u-velocity, Lower:v-velocity. Here a =andre = ; also the correlation length in () is set to b =. The eigenvalues from equation () are =9:67; =:966; =:7; ::: Due to the fast decay of the eigenvalues, we usethefirsttwo terms in the Karhunen-Loeve expansion (9). A fourthorder Polynomial Chaos is used (p = ) and fifteen expansion terms (P = ) are needed. We also assume that

14 only the lower wall is considered to have the non-uniform random boundary condition. The upper wall is set to be stationary and deterministic. The variance of Gaussian process of the lower wall is ff =:. A mesh with elemnts is employed and nineth-order Jacobi polynomial is used as the basis polynomial in each element. A parabolic (no-slip) profile is used at the inlet and fully-developed conditions are asummed at the outlet Figure : Contours of rms of u velocity (upper) and v velocity (lower). Figure shows the velocity contour plot of the deviation of the mean solution at steady-state from a parabolic profile. The mean of u-veclocity remains close to the parabolic shape and the mean of v-velocity, although small in magnitude, is non-zero, in contrast to the case where boundary conditions are uniformly random or deterministic. Figure shows steady-state solutions of the rms (root-mean-square) of u and v-velocity. It is clear that theere is a developing region in the form of a boundary layer emanating at the inlet. Unlike the fully-correlatred case, here all the higher-order expansion terms are non-zero, which implies that although the random input is a Gaussian process, the solution output is not Gaussian. Since there is no analytic solution for this flow with non-uniform random boundary conditions, we employ Monte Carlo (MC) simulation to validate the Polynomial Chaos solution. The deterministic solver of the Navier-Stokes equations is used to compute the flow with each realization of the Gaussian process from the exponential correlation function () as the boundary condition at the lower wall. The MC solution is then obtained by gathering the statistics from the large ensemble of the solutions from such realizations. A brief discussion on the generation of spatially correlated Gaussian fields can be found in Appendix A. For the comparison, we plot the non-dimensionalized variance of velocities, u ms and v ms, along the centerline of the channel. It is defined as Var(u)=ff where Var(u) is defined in equation () and ff is the variance of the input Gaussian field. Figure shows the solution of u ms and v ms along the centerline from MC simulation with,, and

15 U ms. V ms.. PC MC MC MC MC. PC MC MC MC MC - - x - - x Figure : Variance of velocities along the centerline of the channel; Left: u-velocity, Right: v-velocity. realizations, together with the Polynomial Chaos (PC) solution. It is seen that the MC result converges as the number of realizations increases and the solution converges to the PC solution. The advantage of Polynomial Chaos expansion is evident here since the PC solution, with enough terms included for accurate approximation of the randomness, is equivalent to the MC solution with infinite number of realizations. While each single run of PC solution is more expensive than a single deterministic run, in this case about times more expensive asthere are terms in the expansion, it is substantially faster than the Monte Carlo solution which requires thousands of realizations in order to obtain solution statistics with comparable accuracy as the PC solutions. Note that here we employ the standard Monte Carlo simulation without any acceleration algorithms, such asvariance reduction [9].. Micro-channel Flow: Non-Gaussian Input In this section we revisit the pressure-driven micro-channel flow discussed above but with non-gaussian random boundary conditions. Non-Gaussian distributions are not uncommon in micro-fluidics where reactive ion etching techniques cause anisotropies and preferential directions. The Polynomial Chaos expansion procedure can also be applied to non-gaussian processes. The particular non-gaussian input we consider here corresponds to a lognormal distribution. This process has been considered by Ghanem in [7] and [8]. It is chosen because its projection onto the Polynomial Chaos basis can be obtained analytically. If this is not possible, as for most non-gaussian processes, a numerical projection procedure can instead be applied. The lognormal process l is defined as l(x) =e g(x) ; (7) where g is a Gaussian process. We first apply the Karhunen-Loeve expansion of equation (9) to decompose the

16 Gaussian process g(x) as follows g(x) =μg(x)+ nx i= g i (x)ο i ; (8) where g i (x) = p i ffi i (x) according to equation (9). We then expand the lognormal process l(x) by the Polynomial Chaos l(x) = PX i= l i (x)ψ i (ο): (9) The expansion coefficients can be obtained by projecting the lognormal process onto the PC basis l i (x) = <l(x)ψ i > < Ψ i > = <eg(x) Ψ i > < Ψ i > : () By using the Karhunen-Loeve expansion of g(x) (8), the above projection can be obtained analytically: where the terms < Φ i > are listed below, < Φ i >= 8 >< >: l i (x) = < Φ i > < Ψ i > μg(x)+ nx j= g i when Ψ i = ο i ; g i g j when Ψ i = ο i ο j ffi ij ; g i g j g k when Ψ i = ο i ο j ο k ο i ffi jk ο j ffi ki ο k ffi ij ; ::: :::: g j A ; () In case the process g is reduced to a random variable, the expansion of the lognormal variable can be simplified to l = exp ψ μg + ff g! PX j= ff j g j! Ψ j; () where ff g is the variance of the corresponding Gaussian variable g. A more detailed discussion about the lognormal distribution and its Polynomial Chaos approximations can be found in Appendix B... Fully-Correlated Random Boundary Conditions We first consider the case where the boundary conditions at the walls are random but spatially uniform, i.e. all grid points at the boundary are fully-correlated. The exact solution of equation () then applies. By substituting the expansion of lognormal random variable () into the formula, we find that the exact solution consists of the mean u and the random modes corresponding to the inputs from the two walls ο and ο, linearly distributed across the channel. There is no interaction between the two random walls so the cross terms, i.e., terms associated with ο i οj (i 6= j), in the expansion remain zero. Figure 6 shows the velocity modes across the channel. The standard deviations of the underlying Gaussian variables at lower and upper walls are ff = : and ff = :, respectively. Fourth-order Polynomial Chaos is employed (p = ) and the total number of expansion terms is (P = ). Only the nonzero terms, i.e., terms 6

17 ....8 u u u u u 6 u 9 u u..8.. u, u u, u u 6, u u 9, u.7.. 6E- - y - y Figure 6: Distribution of velocity random modes across the channel; Left: first- and second-order (non-zero) random modes, Right: third- and fourth-order (non-zero) random modes. associated with ο or ο only, are plotted (see table for the indices of these terms). We see the linear distribution of the different random modes across the channel. All the cross terms, i.e., terms with the form ο i οj (i 6= j), are zero as expected. The highest order terms, u and u, which are associated with the terms ο and ο, respectively, are of the order of 6. This implies that the fourth-order PC expansion is adequate in this case... Partially-Correlated Random Boundary Conditions Next we consider spatially non-uniform input. The wall boundary condition is considered as a lognormal random process as in equation (7). The underlying Gaussian process g(x) is exactly the same as the one in section.. and the same two-term Karhunen-Loeve expansion is applied to decompose g(x). Monte Carlo simulation is conducted since no exact formula is known. Again only the lower wall is considered to be random and the standard deviation of the underlying Gaussian process is ff = :. The non-dimensionalized variance of velocities, defined similarly as in section.., is plotted along the centerline of the channel in figure 7. Monte Carlo solutions corresponding to, and, realizations are plotted, together with the solution from the Polynomial Chaos expansion. Itcanbeseenthatasthenumber of realizations increases, the MC solution converges to PC solution. The convergence rate is relatively slow due to the large variance of the random input.. Flow Past a Circulat Cylinder In this section we simulate two-dimensional incompressible flow past a circular cylinder with random correlated fluctuations superimposed to the freestream. More specifically, the inflow takes the form u in =μu + g; 7

18 ... U ms. PC MC MC MC V ms. PC MC MC MC - - x - - x Figure 7: Variance of velocities along the centerline of the channel; Left: u-velocity, Right: v-velocity. where g is a Gaussian random variable or process. The size of the computational domain is [ ; ] [ 9; 9] and the cylinder is at the origin with diameter of D =. The Reynolds number Re = based on the mean value of the inflow velocity μu. The domain consists of triangular elements and the Jacobi polynomial in each element for spatial discretization is sixth-order... Fully-Correlated Gaussian Freestream In this case u in = μu + g and g = ffο is a Gaussian random variable, where ff = : is its standard deviation. This results in a one-dimensional PC expansion and we employ fourth-order PC in the simulation. Figure 8 shows the history of pressure signal at the rear stagnation point on the cylinder surface. The signal of the corresponding deterministic simulation is also plotted and it is denoted as P D in dotted line, for reference purposes. It is seen that the amplitude of the mean pressure signal is smaller compared to the deterministic signal due to diffusion induced by the randomness. The higher modes, which describe the stochastic component of the solution, all start from zero then develop gradually from P to P over time. A stationary periodic state is reached after t = in convective time units. Because only the mean and first random modes (Gaussian part) have non-zero boundary inputs, the development to non-zero value of the higher random modes is due to the interactions of the random modes through the nonlinear convective terms in equation (9). Figure 9 shows the instantaneous vorticity distribution from the deterministic simulation and the mean solution from the stochastic simulation at the same time t = 7;both simulations started with identical initial conditions corresponding to a converged periodic state at Re =. Both plots use exactly the same contour levels so that the randomness-induced diffusion in the stochastic solution can be identified in the wake of the cylinder. In figure a 8

19 snapshot of rms of vorticity for the stochastic simulation is shown at the same time t =7..8 P P P P. -. P D P Figure 8: Pressure signal of cylinder flow with uniform random inflow: ff = :. Upper: High modes. Lower: Zero mode (mean). It should be noted that this problem, although still relatively simple, is computationally much more complex than the channel problem, and the approach of Monte Carlo simulation is prohibitively expensive... Partially-Correlated Gaussian Freestream We consider now the more realistic case of partially-correlated freestream velocity. We describe this partial correlation by the exponential covariance kernel of equation () with variance ff =:. A relatively large correlation length is chosen (b = ) such that the first two eigenmodes are adequate to represent theprocess by Karhunen-Loeve expansion (9). Thus, we employ atwo-dimensional PC expansion and third-order polynomials (p = ) (see table for relevant terms). Figure shows the pressure signal, together with the deterministic signal for reference (denoted as P D in dotted line). We see that the stochastic mean pressure signal has a smaller amplitude and it is out of phase with respect to the deterministic signal. Although initially, the stochastic response follows the deterministic reponse, eventually there is a change in the Strouhal frequency as shown in figure. Specifically, the Strouhal frequency of the mean stochastic solution is lower than the deterministic one due to effective lowering of the Reynolds number induced by randomness. We now examine the response of the higher random modes. The first random mode ο is dominant and 9

20 6 y x 6 y x Figure 9: Instantaneous vorticity contours: Upper - Deterministic solution with uniform inflow; Lower - Mean solution with uniform Gaussian random inflow y x Figure : Contours of rms of vorticity field with uniform Gaussian random inflow.

21 P P P P 6 ο is subdominant. Correspondingly, in the higher modes, only the terms associated with ο, i.e., terms P ο ο and P 6 ο ο are active (see table ). These high modes are also plotted in figure (upper plot). In figure we presentvelocity profiles along the centerline for the deterministic and the mean stochastic solution at the same time instant. We see that significant quantitative differences emerge even with a relatively small % uncertainty in the freestream. In figure we plot instantaneous vorticity contours for the mean of the vorticity and compared it with the corresponding plot from the deterministic simulation. There is clearly a strong diffusive effect induced by the randomness. In figure we plot contours of the corresponding rms of vorticity. It shows that the uncertainty influences the most interesting region of the flow, i.e., the shear layers and the vortex street and not the far field..8. Pressure Signal -. Time -. P D P -. Pressure Signal Time Figure : Pressure signal of cylinder flow with non-uniform Gaussian random inflow. Upper: High modes. Lower: Zero mode (mean). Summary and Discussion We have developed a stochastic spectral method to model the uncertainty associated with boundary conditions in simulations of incompressible flows. This method can also be applied to model uncertainty in the boundary domain, e.g. a rough surface, and also to model the uncertainty associated with transport coefficients, e.g. the eddy viscosity in large eddy simulations or other transport models. It sets the foundation for a composite error bar in CFD [] that includes, in addition to the numerical error, contributions due to imprecise input to the simulation. Clearly, this uncertainty is propagated nonlinearly and the new method quantifies statistically the uncertainty in the solution. More specifically, we have employed Wiener-Hermite polynomials to represent the stochastic solution and in

22 . x Deterministic signal Mean random signal: σ=.. Spectrum Frequency Figure : Frequency spectrum for the deterministic (high peak) and stochastic simulation (low peak). U Deterministic U Mean V Deterministic V Mean x Figure : Instantaneous profiles of the two velocity components along the centerline for the deterministic and the mean stochastic solution.

23 y - x y - x Figure : Instantaneous vorticity field: Upper - Deterministic solution with uniform inflow; Lower - Mean solution with non-uniform Gaussian random inflow y - x Figure : Instantaneous contours of rms of vorticity field with non-uniform Gaussian random inflow.

24 particular to discretize the random dimension. We have verified in [] that exponential convergence is obtained for stochastic ordinary differential equations, for which exact solutions are available. On the other hand, it has been reported in the literature that Wiener-Hermite expansions may beconverging slower for certain distribution functions, e.g. for Poisson processes []. This, however, can be rectified by employing a more suitable spectral basis instead of the Hermite polynomials. For example in [] multivariate Charlier polynomials were found to best represent Poisson processes. This can be extended to many different known distributions by employing a basis from the general family of Askey polynomials [], which includes polynomials both for continuous as well as discrete processes. For example, ffl Laguerre polynomials are associated with the Gamma distribution, ffl Meixner polynomials with the Pascal distribution, ffl Krawtchouk polynomials with the Binomial distribution, ffl Jacobi polynomials with the Beta kernel, and ffl Hahn polynomials with the Hypergeometric distribution. For an arbitrary distribution any Wiener-Askey expansion would converge, in accord with the Cameron & Martin theorem [], however certain representations converge faster than others similarly to deterministic spatial expansions. As regards efficiency, a single Polynomial Chaos based simulation, albeit computationally more expensive than the deterministic Navier-Stokes solver, is able to generate the solution statistics equivalent tothemonte Carlo simulation. In the latter, thousands of realizations are required for converged statistics, which is prohibitively expensive for most CFD problems in practice. For example, to obtain converged statistics using the standard Monte Carlo approach for the two-dimensional flow past a cylinder that we presented in section. it would require currently morethana year of computation on a standard workstation compared to about six days for the Polynomial Chaos simulation. Of course a reduced variance version could be employed and also the Monte Carlo simulation is embarassingly parallel, and thus it can be accelerated greatly. However, the Polynomial Chaos based stochastic simuilation can also be done in parallel. One possible strategy is to distribute one random mode per processor, as the bulk of the work is parallel due to linearity, and transpose the data to perform the nonlinear products in a separate step. Even with a modest parallel efficiency, the aforementioned computation would be completed in less than a day on a fifteen-processor computer.

25 A Generation of Correlated Gaussian Random Fields While numerous routines are available for generating independent Gaussian random variables, it is often needed to generate a correlated Gaussian field (vector) with given correlation structure. In general, this can be performed by means of: () Spectral representation; () ARMA (Auto-Regressive Moving Average) modeling; and () Covariance matrix decomposition procedures. There are two approaches for covariance matrix decomposition methods: The Cholesky decomposition method and the modal decomposition method. In this section we briefly review the Cholesky decomposition method [] and the first-order ARMA method. A. The Cholesky Decomposition Method Without loss of generality, we consider the normal random vector x = (x ;x ; ;x n ) with zero mean, i.e., each x i (i =;:::;n) is a Gaussian random variable with zero mean. Let us denote its covariance matrix as C = We then call x the normal random vector of N(; C). 6 ff ff n..... ff n ff nn 7 : () Random field Independent Gaussian field Correlation length = Correlation length = 7 index Figure 6: Correlated Gaussian random field with exponential correlation structure (correlation length is nondimensionalized by the size of the domain) Let y be distributed N(; I n ) where I n is the unit matrix of size n, i.e., y is an independent (uncorrelated)

26 Gaussian random field. Let also x = Ay, then x is distributed N(; AA T )wherea T is the transpose of A. This result is a special case of a more general theorem by Anderson []. The problem of generating Gaussian random field with given correlation structure C is then transformed to the problem of finding matrix A such that AA T = C. Since matrix C is real and symmetric, this can be readily done by the Cholesky's decomposition, where A takes the form of a lower-triangular matrix: a i = ff i = p ff ;» i» n; a ii = q h P j ff ij ff ii P i k= a ik ; <i» n; i a ij = a k= ika jk =a jj ; <j<i» n; a ij = ; i<j» n: () Once the a ij 's have been determined according to the given ff ij 's, we need to generate an n-dimensional independent Gaussian vector y, and subsequently perform the transformation x = Ay. The resulting Gaussian random vector x will have the desired correlation structure C = fff ij g. Figure 6 shows the correlated Gaussian field of the exponential correlation function defined in () with unit variance. The correlation length is non-dimensionalized by the size of the domain. The two results with correlation length of and are both obtained by applying the above Cholesky decomposition method to the same independent Gaussian field also shown in the figure. We see that the original field is uncorrelated and by increasing the correlation length the correlation structure of the field becomes stronger. A. First-Order ARMA Process Method Another way of generating correlated Gaussian field is based on the idea of employing the first-order Auto-regressive (AR()) process, also called the Markov process. This method works specifically for the exponential covariance function () C(x ;x )=e jx x j b ; () where b is the correlation length. The stationary AR() process is defined as, x i = ffx i + ff y y i ; jffj < ; (6) where fy i g is the set of independent Gaussian variables with zero mean and unit variance. It can be shown that the stationary AR() process has the following properties []: E(x i ) = ; (7) Var(x i ) = ff y ff ; (8) C(x i ;x i±k ) = ff jkj ; k =; ±; ±;::: (9) 6

27 It is then straightforward to show that by choosing the parameters ff = e b ; ff y = p ff ; () the resulting random vector x = fx i g is a Gaussian random field with the exponential covariance kernel (equation ()). B Lognormal Distribution and its Approximations While the normal distribution arises from the sum of many small effects according to the Central Limit Theorem, the lognormal distribution arises as the result of a multiplicative mechanism. Let X denote a Gaussian random variable, the lognormal random variable is obtained by taking the exponential of X, Y = e X ; X =lny: () A random variable Y whose logarithms are normally distributed is said to have the lognormal distribution. The PDF (Probability Density Function) of the Gaussian variable X is: f X (x) = ff X p ß exp " x mx ff X # ;» x»; () where m X and ff X are the mean and variance of the Gaussian random variable X, respectively. Equation () defines a one-to-one monotonic transformation. It is well known that when such transformation in the form of Y = g(x) exists, the PDF of the new random variable Y is: f Y (y) = fi dg Therefore, upon substitution the PDF of the lognormal distribution is: f Y (y) = yff X p ß exp The moments of lognormal distribution can be calculated as follows [6]: fi fi fi fi fififi dy (y) f X (g (y)): () " ln y mx ff X # ; y : () <Y r >= e rmx e r ff X ; r =; ;::: () The Polynomial Chaos expansion to the lognormal random variable is given in equation (). Y =exp m X + ff X PX j= ff j X j! Ψ j; (6) 7

28 Upon substituting the one-dimensional Polynomial Chaos (equation (7)) we obtain the first few terms of the approximation:» Y = c +ff X ο + ff X! (ο ) + ff X! (ο ο)+ ; c = e mx + ff X : (7) The Taylor expansion-like formula approximates the lognormal distribution with a Gaussian distribution and higherorder non-gaussian correction terms. The PDF of the Polynomial Chaos approximation can be obtained via several common techniques such as the method of Cumulative Distribution Function (CDF) [7]:. First-order approximation: Y = c( + ff X ο); (8) f (y) = cff X f(ff); ff = y c : (9). Second-order approximation: where» Y = c +ff X ο + ff X! (ο ) ; (6) f (y) = cff X r [f(ff )+f(ff )] ; (6) ff ; = q ( ± r); r = +ffx ff +y=c: X. Third-order approximation: where r =» Y = c + ff X! (ο ) + ff X! (ο ο) ; (6)» f (y) = ffx + ff X ( ff X ) cff X b b + y=c r q 6y=c +9(y=c) ff X +ff X ff6 X ; b = ff X ( y=c + r) = ; f(ff); (6) and ff = + ff X ffx ff X b b : ffx In the above equations, the function f(x) = p ß e x = is the PDF for the standard Gaussian variable ο which has zero mean and unit variance. Figure 7 shows the PDFs of the first-, second- and third-order PC approximations to the lognormal distribution, together with the exact lognormal PDF. The results are obtained with m X = and ff X =:. It can be seen that the first-order approximation (8) is symmetric because it only contains the Gaussian term. As more high-order terms are added, the PDFs become asymmetric and the third-order expansion gives a very good approximation. 8

29 .. exact st order nd order rd order Figure 7: Probability density functions (PDF) of the lognormal distribution and its st-, nd- and rd-order Polynomial Chaos approximations. Acknowledgements We would like to thank Dr. M. Jardak, D. Lucor, Prof. C.-H. Su and Prof. R. Ghanem for useful discussions. This work was supported by ONR and computations were performed at Brown's TCASCV and NCSA's (University of Illinois) facilities. 9

30 References [] Workshop on Validation and Verification of Computational Mechanics Codes. Technical report, Caltech, December 998. [] Workshop on Predictability of Complex Phenomena, Los Alamos, 6-8 December 999. Technical report. [] Workshop on Decision Making Under Uncertainty, IMA, 6-7 September 999. Technical report. [] T.J. Oden, W. Wu, and M. Ainsworth. An a posteriori error estimate for finite element approximations of the Navier-Stokes equations. Comp. Meth. Appl. Mech. Eng., :8, 99. [] L. Machiels, J. Peraire, and A.T. Patera. A posteriori finite element output bounds for the incompressible Navier-Stokes equations; application to a natural convection problem. J. Comp. Phys., to appear,. [6] R.G. Hills and T.G. Trucano. Statistical validation of engineering and scientific models: Background. Technical Report SAND99-6, Sandia National Laboratories, 999. [7] R.G. Ghanem. Stochastic finite elements for heterogeneous media with multiple random non-gaussian properties. ASCE J. Eng. Mech., ():6, 999. [8] R.G. Ghanem. Ingredients for a general purpose stochastic finite element formulation. Comp. Meth. Appl. Mech. Eng., 68:9, 999. [9] T.D. Fadale and A.F. Emery. Transient effects of uncertainties on the sensitivities of temperatures and heat fluxes using stochastic finite elements. J. Heat Trans., 6:88 8, 99. [] R.G. Ghanem and P. Spanos. Stochastic finite elements: a spectral approach. Springer-Verlag, 99. [] W.K. Liu, G. Besterfield, and A. Mani. Probabilistic finite elements in nonlinear structural dynamics. Comp. Meth. Appl. Mech. Eng., 6:6 8, 986. [] W.K. Liu, A. Mani, and T. Belytschko. Finite element methods in probabilistic mechanics. Probabilistic Eng. Mech., ():, 987. [] M. Shinozuka and E. Leone. A probabilistic model for spatial distribution of material properties. Eng. Fracture Mech., 8:7 7, 976. [] M. Shinozuka. Structural response variability. J. Eng. Mech., (6):8 8, 987.

Modeling Uncertainty in Flow Simulations via Generalized Polynomial Chaos

Modeling Uncertainty in Flow Simulations via Generalized Polynomial Chaos Modeling Uncertainty in Flow Simulations via Generalized Polynomial Chaos Dongbin Xiu and George Em Karniadakis Division of Applied Mathematics Brown University Providence, RI 9 Submitted to Journal of

More information

Performance Evaluation of Generalized Polynomial Chaos

Performance Evaluation of Generalized Polynomial Chaos Performance Evaluation of Generalized Polynomial Chaos Dongbin Xiu, Didier Lucor, C.-H. Su, and George Em Karniadakis 1 Division of Applied Mathematics, Brown University, Providence, RI 02912, USA, gk@dam.brown.edu

More information

Final Report: DE-FG02-95ER25239 Spectral Representations of Uncertainty: Algorithms and Applications

Final Report: DE-FG02-95ER25239 Spectral Representations of Uncertainty: Algorithms and Applications Final Report: DE-FG02-95ER25239 Spectral Representations of Uncertainty: Algorithms and Applications PI: George Em Karniadakis Division of Applied Mathematics, Brown University April 25, 2005 1 Objectives

More information

Stochastic Modeling of Flow-Structure Interactions Using Generalized Polynomial Chaos

Stochastic Modeling of Flow-Structure Interactions Using Generalized Polynomial Chaos Dongbin Xiu Didier Lucor C.-H. Su George Em Karniadakis 1 Division of Applied Mathematics, Brown University, rovidence, RI 02912 Stochastic Modeling of Flow-Structure Interactions Using Generalized olynomial

More information

c 2004 Society for Industrial and Applied Mathematics

c 2004 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 6, No., pp. 578 59 c Society for Industrial and Applied Mathematics STOCHASTIC SOLUTIONS FOR THE TWO-DIMENSIONAL ADVECTION-DIFFUSION EQUATION XIAOLIANG WAN, DONGBIN XIU, AND GEORGE

More information

A Non-Intrusive Polynomial Chaos Method For Uncertainty Propagation in CFD Simulations

A Non-Intrusive Polynomial Chaos Method For Uncertainty Propagation in CFD Simulations An Extended Abstract submitted for the 44th AIAA Aerospace Sciences Meeting and Exhibit, Reno, Nevada January 26 Preferred Session Topic: Uncertainty quantification and stochastic methods for CFD A Non-Intrusive

More information

Stochastic Modeling of Flow-Structure Interactions using Generalized Polynomial Chaos

Stochastic Modeling of Flow-Structure Interactions using Generalized Polynomial Chaos Stochastic Modeling of Flow-Structure Interactions using Generalized Polynomial Chaos Dongbin Xiu, Didier Lucor, C.-H. Su and George Em Karniadakis Division of Applied Mathematics Brown University Providence,

More information

Spectral Polynomial Chaos Solutions of the Stochastic Advection Equation

Spectral Polynomial Chaos Solutions of the Stochastic Advection Equation Spectral Polynomial Chaos Solutions of the Stochastic Advection Equation M. Jardak, C.-H. Su and G.E. Karniadakis Division of Applied Mathematics Brown University October 29, 21 Abstract We present a new

More information

Fast Numerical Methods for Stochastic Computations

Fast Numerical Methods for Stochastic Computations Fast AreviewbyDongbinXiu May 16 th,2013 Outline Motivation 1 Motivation 2 3 4 5 Example: Burgers Equation Let us consider the Burger s equation: u t + uu x = νu xx, x [ 1, 1] u( 1) =1 u(1) = 1 Example:

More information

Beyond Wiener Askey Expansions: Handling Arbitrary PDFs

Beyond Wiener Askey Expansions: Handling Arbitrary PDFs Journal of Scientific Computing, Vol. 27, Nos. 1 3, June 2006 ( 2005) DOI: 10.1007/s10915-005-9038-8 Beyond Wiener Askey Expansions: Handling Arbitrary PDFs Xiaoliang Wan 1 and George Em Karniadakis 1

More information

Modeling Uncertainty in Steady State Diffusion Problems via Generalized Polynomial Chaos

Modeling Uncertainty in Steady State Diffusion Problems via Generalized Polynomial Chaos Modeling Uncertainty in Steady State Diffusion Problems via Generalized Polynomial Chaos Dongbin Xiu and George Em Karniadakis Division of Applied Mathematics Brown University Providence, RI 09 Submitted

More information

Stochastic Solvers for the Euler Equations

Stochastic Solvers for the Euler Equations 43rd AIAA Aerospace Sciences Meeting and Exhibit 1-13 January 5, Reno, Nevada 5-873 Stochastic Solvers for the Euler Equations G. Lin, C.-H. Su and G.E. Karniadakis Division of Applied Mathematics Brown

More information

STOCHASTIC FINITE ELEMENTS WITH MULTIPLE RANDOM NON-GAUSSIAN PROPERTIES

STOCHASTIC FINITE ELEMENTS WITH MULTIPLE RANDOM NON-GAUSSIAN PROPERTIES STOCHASTIC FIITE ELEMETS WITH MULTIPLE RADOM O-GAUSSIA PROPERTIES By Roger Ghanem, 1 Member, ASCE ABSTRACT: The spectral formulation of the stochastic finite-element method is applied to the problem of

More information

A Polynomial Chaos Approach to Robust Multiobjective Optimization

A Polynomial Chaos Approach to Robust Multiobjective Optimization A Polynomial Chaos Approach to Robust Multiobjective Optimization Silvia Poles 1, Alberto Lovison 2 1 EnginSoft S.p.A., Optimization Consulting Via Giambellino, 7 35129 Padova, Italy s.poles@enginsoft.it

More information

Polynomial chaos expansions for sensitivity analysis

Polynomial chaos expansions for sensitivity analysis c DEPARTMENT OF CIVIL, ENVIRONMENTAL AND GEOMATIC ENGINEERING CHAIR OF RISK, SAFETY & UNCERTAINTY QUANTIFICATION Polynomial chaos expansions for sensitivity analysis B. Sudret Chair of Risk, Safety & Uncertainty

More information

Polynomial Chaos and Karhunen-Loeve Expansion

Polynomial Chaos and Karhunen-Loeve Expansion Polynomial Chaos and Karhunen-Loeve Expansion 1) Random Variables Consider a system that is modeled by R = M(x, t, X) where X is a random variable. We are interested in determining the probability of the

More information

Fast Numerical Methods for Stochastic Computations: A Review

Fast Numerical Methods for Stochastic Computations: A Review COMMUNICATIONS IN COMPUTATIONAL PHYSICS Vol. 5, No. 2-4, pp. 242-272 Commun. Comput. Phys. February 2009 REVIEW ARTICLE Fast Numerical Methods for Stochastic Computations: A Review Dongbin Xiu Department

More information

(U c. t)/b (U t)/b

(U c. t)/b (U t)/b DYNAMICAL MODELING OF THE LARGE-SCALE MOTION OF A PLANAR TURBULENT JET USING POD MODES. S. Gordeyev 1 and F. O. Thomas 1 University of Notre Dame, Notre Dame, USA University of Notre Dame, Notre Dame,

More information

Estimating functional uncertainty using polynomial chaos and adjoint equations

Estimating functional uncertainty using polynomial chaos and adjoint equations 0. Estimating functional uncertainty using polynomial chaos and adjoint equations February 24, 2011 1 Florida State University, Tallahassee, Florida, Usa 2 Moscow Institute of Physics and Technology, Moscow,

More information

Stochastic Spectral Approaches to Bayesian Inference

Stochastic Spectral Approaches to Bayesian Inference Stochastic Spectral Approaches to Bayesian Inference Prof. Nathan L. Gibson Department of Mathematics Applied Mathematics and Computation Seminar March 4, 2011 Prof. Gibson (OSU) Spectral Approaches to

More information

PARALLEL COMPUTATION OF 3D WAVE PROPAGATION BY SPECTRAL STOCHASTIC FINITE ELEMENT METHOD

PARALLEL COMPUTATION OF 3D WAVE PROPAGATION BY SPECTRAL STOCHASTIC FINITE ELEMENT METHOD 13 th World Conference on Earthquake Engineering Vancouver, B.C., Canada August 1-6, 24 Paper No. 569 PARALLEL COMPUTATION OF 3D WAVE PROPAGATION BY SPECTRAL STOCHASTIC FINITE ELEMENT METHOD Riki Honda

More information

Solving the steady state diffusion equation with uncertainty Final Presentation

Solving the steady state diffusion equation with uncertainty Final Presentation Solving the steady state diffusion equation with uncertainty Final Presentation Virginia Forstall vhfors@gmail.com Advisor: Howard Elman elman@cs.umd.edu Department of Computer Science May 6, 2012 Problem

More information

Introduction to Uncertainty Quantification in Computational Science Handout #3

Introduction to Uncertainty Quantification in Computational Science Handout #3 Introduction to Uncertainty Quantification in Computational Science Handout #3 Gianluca Iaccarino Department of Mechanical Engineering Stanford University June 29 - July 1, 2009 Scuola di Dottorato di

More information

Dinesh Kumar, Mehrdad Raisee and Chris Lacor

Dinesh Kumar, Mehrdad Raisee and Chris Lacor Dinesh Kumar, Mehrdad Raisee and Chris Lacor Fluid Mechanics and Thermodynamics Research Group Vrije Universiteit Brussel, BELGIUM dkumar@vub.ac.be; m_raisee@yahoo.com; chris.lacor@vub.ac.be October, 2014

More information

UNCERTAINTY ASSESSMENT USING STOCHASTIC REDUCED BASIS METHOD FOR FLOW IN POROUS MEDIA

UNCERTAINTY ASSESSMENT USING STOCHASTIC REDUCED BASIS METHOD FOR FLOW IN POROUS MEDIA UNCERTAINTY ASSESSMENT USING STOCHASTIC REDUCED BASIS METHOD FOR FLOW IN POROUS MEDIA A REPORT SUBMITTED TO THE DEPARTMENT OF ENERGY RESOURCES ENGINEERING OF STANFORD UNIVERSITY IN PARTIAL FULFILLMENT

More information

A reduced-order stochastic finite element analysis for structures with uncertainties

A reduced-order stochastic finite element analysis for structures with uncertainties A reduced-order stochastic finite element analysis for structures with uncertainties Ji Yang 1, Béatrice Faverjon 1,2, Herwig Peters 1, icole Kessissoglou 1 1 School of Mechanical and Manufacturing Engineering,

More information

Uncertainty Quantification and hypocoercivity based sensitivity analysis for multiscale kinetic equations with random inputs.

Uncertainty Quantification and hypocoercivity based sensitivity analysis for multiscale kinetic equations with random inputs. Uncertainty Quantification and hypocoercivity based sensitivity analysis for multiscale kinetic equations with random inputs Shi Jin University of Wisconsin-Madison, USA Shanghai Jiao Tong University,

More information

An Empirical Chaos Expansion Method for Uncertainty Quantification

An Empirical Chaos Expansion Method for Uncertainty Quantification An Empirical Chaos Expansion Method for Uncertainty Quantification Melvin Leok and Gautam Wilkins Abstract. Uncertainty quantification seeks to provide a quantitative means to understand complex systems

More information

EFFICIENT SHAPE OPTIMIZATION USING POLYNOMIAL CHAOS EXPANSION AND LOCAL SENSITIVITIES

EFFICIENT SHAPE OPTIMIZATION USING POLYNOMIAL CHAOS EXPANSION AND LOCAL SENSITIVITIES 9 th ASCE Specialty Conference on Probabilistic Mechanics and Structural Reliability EFFICIENT SHAPE OPTIMIZATION USING POLYNOMIAL CHAOS EXPANSION AND LOCAL SENSITIVITIES Nam H. Kim and Haoyu Wang University

More information

Uncertainty quantification for flow in highly heterogeneous porous media

Uncertainty quantification for flow in highly heterogeneous porous media 695 Uncertainty quantification for flow in highly heterogeneous porous media D. Xiu and D.M. Tartakovsky a a Theoretical Division, Los Alamos National Laboratory, Mathematical Modeling and Analysis Group

More information

Validation 3. Laminar Flow Around a Circular Cylinder

Validation 3. Laminar Flow Around a Circular Cylinder Validation 3. Laminar Flow Around a Circular Cylinder 3.1 Introduction Steady and unsteady laminar flow behind a circular cylinder, representing flow around bluff bodies, has been subjected to numerous

More information

NUMERICAL SIMULATION OF THE FLOW AROUND A SQUARE CYLINDER USING THE VORTEX METHOD

NUMERICAL SIMULATION OF THE FLOW AROUND A SQUARE CYLINDER USING THE VORTEX METHOD NUMERICAL SIMULATION OF THE FLOW AROUND A SQUARE CYLINDER USING THE VORTEX METHOD V. G. Guedes a, G. C. R. Bodstein b, and M. H. Hirata c a Centro de Pesquisas de Energia Elétrica Departamento de Tecnologias

More information

Efficient Solvers for Stochastic Finite Element Saddle Point Problems

Efficient Solvers for Stochastic Finite Element Saddle Point Problems Efficient Solvers for Stochastic Finite Element Saddle Point Problems Catherine E. Powell c.powell@manchester.ac.uk School of Mathematics University of Manchester, UK Efficient Solvers for Stochastic Finite

More information

Numerical Investigation of Thermal Performance in Cross Flow Around Square Array of Circular Cylinders

Numerical Investigation of Thermal Performance in Cross Flow Around Square Array of Circular Cylinders Numerical Investigation of Thermal Performance in Cross Flow Around Square Array of Circular Cylinders A. Jugal M. Panchal, B. A M Lakdawala 2 A. M. Tech student, Mechanical Engineering Department, Institute

More information

Safety Envelope for Load Tolerance and Its Application to Fatigue Reliability Design

Safety Envelope for Load Tolerance and Its Application to Fatigue Reliability Design Safety Envelope for Load Tolerance and Its Application to Fatigue Reliability Design Haoyu Wang * and Nam H. Kim University of Florida, Gainesville, FL 32611 Yoon-Jun Kim Caterpillar Inc., Peoria, IL 61656

More information

Uncertainty Quantification for multiscale kinetic equations with random inputs. Shi Jin. University of Wisconsin-Madison, USA

Uncertainty Quantification for multiscale kinetic equations with random inputs. Shi Jin. University of Wisconsin-Madison, USA Uncertainty Quantification for multiscale kinetic equations with random inputs Shi Jin University of Wisconsin-Madison, USA Where do kinetic equations sit in physics Kinetic equations with applications

More information

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2.

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2. APPENDIX A Background Mathematics A. Linear Algebra A.. Vector algebra Let x denote the n-dimensional column vector with components 0 x x 2 B C @. A x n Definition 6 (scalar product). The scalar product

More information

Keywords: Sonic boom analysis, Atmospheric uncertainties, Uncertainty quantification, Monte Carlo method, Polynomial chaos method.

Keywords: Sonic boom analysis, Atmospheric uncertainties, Uncertainty quantification, Monte Carlo method, Polynomial chaos method. Blucher Mechanical Engineering Proceedings May 2014, vol. 1, num. 1 www.proceedings.blucher.com.br/evento/10wccm SONIC BOOM ANALYSIS UNDER ATMOSPHERIC UNCERTAINTIES BY A NON-INTRUSIVE POLYNOMIAL CHAOS

More information

arxiv: v1 [math.na] 3 Apr 2019

arxiv: v1 [math.na] 3 Apr 2019 arxiv:1904.02017v1 [math.na] 3 Apr 2019 Poly-Sinc Solution of Stochastic Elliptic Differential Equations Maha Youssef and Roland Pulch Institute of Mathematics and Computer Science, University of Greifswald,

More information

Stochastic low-dimensional modelling of a random laminar wake past a circular cylinder

Stochastic low-dimensional modelling of a random laminar wake past a circular cylinder J. Fluid Mech. (28), vol. 66, pp. 33967. c 28 Cambridge University Press doi:1.117/s2211281821 Printed in the United Kingdom 339 Stochastic low-dimensional modelling of a random laminar wake past a circular

More information

EFFICIENT STOCHASTIC GALERKIN METHODS FOR RANDOM DIFFUSION EQUATIONS

EFFICIENT STOCHASTIC GALERKIN METHODS FOR RANDOM DIFFUSION EQUATIONS EFFICIENT STOCHASTIC GALERKIN METHODS FOR RANDOM DIFFUSION EQUATIONS DONGBIN XIU AND JIE SHEN Abstract. We discuss in this paper efficient solvers for stochastic diffusion equations in random media. We

More information

Mathematical Preliminaries

Mathematical Preliminaries Mathematical Preliminaries Introductory Course on Multiphysics Modelling TOMAZ G. ZIELIŃKI bluebox.ippt.pan.pl/ tzielins/ Table of Contents Vectors, tensors, and index notation. Generalization of the concept

More information

An example of the Rvachev function method

An example of the Rvachev function method arxiv:1603.00320v1 [physics.flu-dyn] 1 Mar 2016 An example of the Rvachev function method Alexander V. Proskurin Altai State University, Altai State Technical University, k210@list.ru Anatoly M. Sagalakov

More information

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION 7.1 THE NAVIER-STOKES EQUATIONS Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

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

Probability density function (PDF) methods 1,2 belong to the broader family of statistical approaches

Probability density function (PDF) methods 1,2 belong to the broader family of statistical approaches Joint probability density function modeling of velocity and scalar in turbulence with unstructured grids arxiv:6.59v [physics.flu-dyn] Jun J. Bakosi, P. Franzese and Z. Boybeyi George Mason University,

More information

WALL RESOLUTION STUDY FOR DIRECT NUMERICAL SIMULATION OF TURBULENT CHANNEL FLOW USING A MULTIDOMAIN CHEBYSHEV GRID

WALL RESOLUTION STUDY FOR DIRECT NUMERICAL SIMULATION OF TURBULENT CHANNEL FLOW USING A MULTIDOMAIN CHEBYSHEV GRID WALL RESOLUTION STUDY FOR DIRECT NUMERICAL SIMULATION OF TURBULENT CHANNEL FLOW USING A MULTIDOMAIN CHEBYSHEV GRID Zia Ghiasi sghias@uic.edu Dongru Li dli@uic.edu Jonathan Komperda jonk@uic.edu Farzad

More information

Collocation based high dimensional model representation for stochastic partial differential equations

Collocation based high dimensional model representation for stochastic partial differential equations Collocation based high dimensional model representation for stochastic partial differential equations S Adhikari 1 1 Swansea University, UK ECCM 2010: IV European Conference on Computational Mechanics,

More information

Uncertainty Quantification in MEMS

Uncertainty Quantification in MEMS Uncertainty Quantification in MEMS N. Agarwal and N. R. Aluru Department of Mechanical Science and Engineering for Advanced Science and Technology Introduction Capacitive RF MEMS switch Comb drive Various

More information

The JHU Turbulence Databases (JHTDB)

The JHU Turbulence Databases (JHTDB) The JHU Turbulence Databases (JHTDB) TURBULENT CHANNEL FLOW AT Re τ = 5200 DATA SET Data provenance: M. Lee 1 & R. D. Moser 1 Database ingest and Web Services: Z. Wu 2, G. Lemson 2, R. Burns 2, A. Szalay

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

Schwarz Preconditioner for the Stochastic Finite Element Method

Schwarz Preconditioner for the Stochastic Finite Element Method Schwarz Preconditioner for the Stochastic Finite Element Method Waad Subber 1 and Sébastien Loisel 2 Preprint submitted to DD22 conference 1 Introduction The intrusive polynomial chaos approach for uncertainty

More information

Micro-Scale Gas Transport Modeling

Micro-Scale Gas Transport Modeling Micro-Scale Gas Transport Modeling Continuum & Slip Flow Regimes: Navier-Stokes Equations Slip Boundary Conditions U g U w = ( σ ) σ U Kn n Slip, Transitional & Free Molecular: Direct Simulation Monte

More information

Probabilistic Collocation Method for Uncertainty Analysis of Soil Infiltration in Flood Modelling

Probabilistic Collocation Method for Uncertainty Analysis of Soil Infiltration in Flood Modelling Probabilistic Collocation Method for Uncertainty Analysis of Soil Infiltration in Flood Modelling Y. Huang 1,2, and X.S. Qin 1,2* 1 School of Civil & Environmental Engineering, Nanyang Technological University,

More information

Turbulent drag reduction by streamwise traveling waves

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

More information

Uncertainty Quantification in Computational Science

Uncertainty Quantification in Computational Science DTU 2010 - Lecture I Uncertainty Quantification in Computational Science Jan S Hesthaven Brown University Jan.Hesthaven@Brown.edu Objective of lectures The main objective of these lectures are To offer

More information

Characterization of heterogeneous hydraulic conductivity field via Karhunen-Loève expansions and a measure-theoretic computational method

Characterization of heterogeneous hydraulic conductivity field via Karhunen-Loève expansions and a measure-theoretic computational method Characterization of heterogeneous hydraulic conductivity field via Karhunen-Loève expansions and a measure-theoretic computational method Jiachuan He University of Texas at Austin April 15, 2016 Jiachuan

More information

Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions

Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions Johan Hoffman May 14, 2006 Abstract In this paper we use a General Galerkin (G2) method to simulate drag crisis for a sphere,

More information

c 2004 Society for Industrial and Applied Mathematics

c 2004 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 26, No. 2, pp. 558 577 c 2004 Society for Industrial and Applied Mathematics A COMPARATIVE STUDY ON UNCERTAINTY QUANTIFICATION FOR FLOW IN RANDOMLY HETEROGENEOUS MEDIA USING MONTE

More information

Solving the stochastic steady-state diffusion problem using multigrid

Solving the stochastic steady-state diffusion problem using multigrid IMA Journal of Numerical Analysis (2007) 27, 675 688 doi:10.1093/imanum/drm006 Advance Access publication on April 9, 2007 Solving the stochastic steady-state diffusion problem using multigrid HOWARD ELMAN

More information

Boundary-Layer Theory

Boundary-Layer Theory Hermann Schlichting Klaus Gersten Boundary-Layer Theory With contributions from Egon Krause and Herbert Oertel Jr. Translated by Katherine Mayes 8th Revised and Enlarged Edition With 287 Figures and 22

More information

TECHNISCHE UNIVERSITÄT MÜNCHEN. Uncertainty Quantification in Fluid Flows via Polynomial Chaos Methodologies

TECHNISCHE UNIVERSITÄT MÜNCHEN. Uncertainty Quantification in Fluid Flows via Polynomial Chaos Methodologies TECHNISCHE UNIVERSITÄT MÜNCHEN Bachelor s Thesis in Engineering Science Uncertainty Quantification in Fluid Flows via Polynomial Chaos Methodologies Jan Sültemeyer DEPARTMENT OF INFORMATICS MUNICH SCHOOL

More information

Chapter 2 Spectral Expansions

Chapter 2 Spectral Expansions Chapter 2 Spectral Expansions In this chapter, we discuss fundamental and practical aspects of spectral expansions of random model data and of model solutions. We focus on a specific class of random process

More information

Anisotropic grid-based formulas. for subgrid-scale models. By G.-H. Cottet 1 AND A. A. Wray

Anisotropic grid-based formulas. for subgrid-scale models. By G.-H. Cottet 1 AND A. A. Wray Center for Turbulence Research Annual Research Briefs 1997 113 Anisotropic grid-based formulas for subgrid-scale models By G.-H. Cottet 1 AND A. A. Wray 1. Motivations and objectives Anisotropic subgrid-scale

More information

Uncertainty Quantification for multiscale kinetic equations with high dimensional random inputs with sparse grids

Uncertainty Quantification for multiscale kinetic equations with high dimensional random inputs with sparse grids Uncertainty Quantification for multiscale kinetic equations with high dimensional random inputs with sparse grids Shi Jin University of Wisconsin-Madison, USA Kinetic equations Different Q Boltmann Landau

More information

Benjamin L. Pence 1, Hosam K. Fathy 2, and Jeffrey L. Stein 3

Benjamin L. Pence 1, Hosam K. Fathy 2, and Jeffrey L. Stein 3 2010 American Control Conference Marriott Waterfront, Baltimore, MD, USA June 30-July 02, 2010 WeC17.1 Benjamin L. Pence 1, Hosam K. Fathy 2, and Jeffrey L. Stein 3 (1) Graduate Student, (2) Assistant

More information

Monte Carlo Methods for Uncertainty Quantification

Monte Carlo Methods for Uncertainty Quantification Monte Carlo Methods for Uncertainty Quantification Mike Giles Mathematical Institute, University of Oxford Contemporary Numerical Techniques Mike Giles (Oxford) Monte Carlo methods 1 / 23 Lecture outline

More information

SENSITIVITY ANALYSIS IN NUMERICAL SIMULATION OF MULTIPHASE FLOW FOR CO 2 STORAGE IN SALINE AQUIFERS USING THE PROBABILISTIC COLLOCATION APPROACH

SENSITIVITY ANALYSIS IN NUMERICAL SIMULATION OF MULTIPHASE FLOW FOR CO 2 STORAGE IN SALINE AQUIFERS USING THE PROBABILISTIC COLLOCATION APPROACH XIX International Conference on Water Resources CMWR 2012 University of Illinois at Urbana-Champaign June 17-22,2012 SENSITIVITY ANALYSIS IN NUMERICAL SIMULATION OF MULTIPHASE FLOW FOR CO 2 STORAGE IN

More information

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

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

More information

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation Faheem Ahmed, Fareed Ahmed, Yongheng Guo, Yong Yang Abstract This paper deals with

More information

EXACT SOLUTIONS TO THE NAVIER-STOKES EQUATION FOR AN INCOMPRESSIBLE FLOW FROM THE INTERPRETATION OF THE SCHRÖDINGER WAVE FUNCTION

EXACT SOLUTIONS TO THE NAVIER-STOKES EQUATION FOR AN INCOMPRESSIBLE FLOW FROM THE INTERPRETATION OF THE SCHRÖDINGER WAVE FUNCTION EXACT SOLUTIONS TO THE NAVIER-STOKES EQUATION FOR AN INCOMPRESSIBLE FLOW FROM THE INTERPRETATION OF THE SCHRÖDINGER WAVE FUNCTION Vladimir V. KULISH & José L. LAGE School of Mechanical & Aerospace Engineering,

More information

Stochastic Particle Methods for Rarefied Gases

Stochastic Particle Methods for Rarefied Gases CCES Seminar WS 2/3 Stochastic Particle Methods for Rarefied Gases Julian Köllermeier RWTH Aachen University Supervisor: Prof. Dr. Manuel Torrilhon Center for Computational Engineering Science Mathematics

More information

Uncertainty Evolution In Stochastic Dynamic Models Using Polynomial Chaos

Uncertainty Evolution In Stochastic Dynamic Models Using Polynomial Chaos Noname manuscript No. (will be inserted by the editor) Uncertainty Evolution In Stochastic Dynamic Models Using Polynomial Chaos Umamaheswara Konda Puneet Singla Tarunraj Singh Peter Scott Received: date

More information

Some remarks on grad-div stabilization of incompressible flow simulations

Some remarks on grad-div stabilization of incompressible flow simulations Some remarks on grad-div stabilization of incompressible flow simulations Gert Lube Institute for Numerical and Applied Mathematics Georg-August-University Göttingen M. Stynes Workshop Numerical Analysis

More information

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions R. S. Sellers MAE 5440, Computational Fluid Dynamics Utah State University, Department of Mechanical and Aerospace Engineering

More information

A Vector-Space Approach for Stochastic Finite Element Analysis

A Vector-Space Approach for Stochastic Finite Element Analysis A Vector-Space Approach for Stochastic Finite Element Analysis S Adhikari 1 1 Swansea University, UK CST2010: Valencia, Spain Adhikari (Swansea) Vector-Space Approach for SFEM 14-17 September, 2010 1 /

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

Dynamic System Identification using HDMR-Bayesian Technique

Dynamic System Identification using HDMR-Bayesian Technique Dynamic System Identification using HDMR-Bayesian Technique *Shereena O A 1) and Dr. B N Rao 2) 1), 2) Department of Civil Engineering, IIT Madras, Chennai 600036, Tamil Nadu, India 1) ce14d020@smail.iitm.ac.in

More information

Numerical investigation on vortex-induced motion of a pivoted cylindrical body in uniform flow

Numerical investigation on vortex-induced motion of a pivoted cylindrical body in uniform flow Fluid Structure Interaction VII 147 Numerical investigation on vortex-induced motion of a pivoted cylindrical body in uniform flow H. G. Sung 1, H. Baek 2, S. Hong 1 & J.-S. Choi 1 1 Maritime and Ocean

More information

Chapter 13. Eddy Diffusivity

Chapter 13. Eddy Diffusivity Chapter 13 Eddy Diffusivity Glenn introduced the mean field approximation of turbulence in two-layer quasigesotrophic turbulence. In that approximation one must solve the zonally averaged equations for

More information

The Stochastic Piston Problem

The Stochastic Piston Problem The Stochastic Piston Problem G. Lin, C.-H. Su and G.E. Karniadakis Division of Applied Mathematics 18 George Street Brown University Providence, RI 91 Classification: Physical Sciences: Applied Mathematics

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

Spectral methods for fuzzy structural dynamics: modal vs direct approach

Spectral methods for fuzzy structural dynamics: modal vs direct approach Spectral methods for fuzzy structural dynamics: modal vs direct approach S Adhikari Zienkiewicz Centre for Computational Engineering, College of Engineering, Swansea University, Wales, UK IUTAM Symposium

More information

Revisit to Grad s Closure and Development of Physically Motivated Closure for Phenomenological High-Order Moment Model

Revisit to Grad s Closure and Development of Physically Motivated Closure for Phenomenological High-Order Moment Model Revisit to Grad s Closure and Development of Physically Motivated Closure for Phenomenological High-Order Moment Model R. S. Myong a and S. P. Nagdewe a a Dept. of Mechanical and Aerospace Engineering

More information

Numerical Schemes and Computational Studies for Dynamically Orthogonal Equations. Mattheus P. Ueckermann Pierre F. J. Lermusiaux Themis P.

Numerical Schemes and Computational Studies for Dynamically Orthogonal Equations. Mattheus P. Ueckermann Pierre F. J. Lermusiaux Themis P. Multidisciplinary Simulation, Estimation, and Assimilation Systems Reports in Ocean Science and Engineering MSEAS-11 Numerical Schemes and Computational Studies for Dynamically Orthogonal Equations by

More information

Database analysis of errors in large-eddy simulation

Database analysis of errors in large-eddy simulation PHYSICS OF FLUIDS VOLUME 15, NUMBER 9 SEPTEMBER 2003 Johan Meyers a) Department of Mechanical Engineering, Katholieke Universiteit Leuven, Celestijnenlaan 300, B3001 Leuven, Belgium Bernard J. Geurts b)

More information

Energy Transfer Analysis of Turbulent Plane Couette Flow

Energy Transfer Analysis of Turbulent Plane Couette Flow Energy Transfer Analysis of Turbulent Plane Couette Flow Satish C. Reddy! and Petros J. Ioannou2 1 Department of Mathematics, Oregon State University, Corvallis, OR 97331 USA, reddy@math.orst.edu 2 Department

More information

Dynamic response of structures with uncertain properties

Dynamic response of structures with uncertain properties Dynamic response of structures with uncertain properties S. Adhikari 1 1 Chair of Aerospace Engineering, College of Engineering, Swansea University, Bay Campus, Fabian Way, Swansea, SA1 8EN, UK International

More information

Solution of Stochastic Nonlinear PDEs Using Wiener-Hermite Expansion of High Orders

Solution of Stochastic Nonlinear PDEs Using Wiener-Hermite Expansion of High Orders Solution of Stochastic Nonlinear PDEs Using Wiener-Hermite Expansion of High Orders Dr. Mohamed El-Beltagy 1,2 Joint Wor with Late Prof. Magdy El-Tawil 2 1 Effat University, Engineering College, Electrical

More information

Principles of Convection

Principles of Convection Principles of Convection Point Conduction & convection are similar both require the presence of a material medium. But convection requires the presence of fluid motion. Heat transfer through the: Solid

More information

General introduction to Hydrodynamic Instabilities

General introduction to Hydrodynamic Instabilities KTH ROYAL INSTITUTE OF TECHNOLOGY General introduction to Hydrodynamic Instabilities L. Brandt & J.-Ch. Loiseau KTH Mechanics, November 2015 Luca Brandt Professor at KTH Mechanics Email: luca@mech.kth.se

More information

An evaluation of a conservative fourth order DNS code in turbulent channel flow

An evaluation of a conservative fourth order DNS code in turbulent channel flow Center for Turbulence Research Annual Research Briefs 2 2 An evaluation of a conservative fourth order DNS code in turbulent channel flow By Jessica Gullbrand. Motivation and objectives Direct numerical

More information

Multi-Element Probabilistic Collocation Method in High Dimensions

Multi-Element Probabilistic Collocation Method in High Dimensions Multi-Element Probabilistic Collocation Method in High Dimensions Jasmine Foo and George Em Karniadakis Division of Applied Mathematics, Brown University, Providence, RI 02912 USA Abstract We combine multi-element

More information

MULTI-ELEMENT GENERALIZED POLYNOMIAL CHAOS FOR ARBITRARY PROBABILITY MEASURES

MULTI-ELEMENT GENERALIZED POLYNOMIAL CHAOS FOR ARBITRARY PROBABILITY MEASURES SIAM J. SCI. COMPUT. Vol. 8, No. 3, pp. 9 98 c 6 Society for Industrial and Applied Mathematics MULTI-ELEMENT GENERALIZED POLYNOMIAL CHAOS FOR ARBITRARY PROBABILITY MEASURES XIAOLIANG WAN AND GEORGE EM

More information

Three-dimensional wall filtering formulation for large-eddy simulation

Three-dimensional wall filtering formulation for large-eddy simulation Center for Turbulence Research Annual Research Briefs 6 55 Three-dimensional wall filtering formulation for large-eddy simulation By M. Shoeybi AND J. A. Templeton 1. Motivation and objectives Large-eddy

More information

Turbulence Modeling I!

Turbulence Modeling I! Outline! Turbulence Modeling I! Grétar Tryggvason! Spring 2010! Why turbulence modeling! Reynolds Averaged Numerical Simulations! Zero and One equation models! Two equations models! Model predictions!

More information

2. SPECTRAL ANALYSIS APPLIED TO STOCHASTIC PROCESSES

2. SPECTRAL ANALYSIS APPLIED TO STOCHASTIC PROCESSES 2. SPECTRAL ANALYSIS APPLIED TO STOCHASTIC PROCESSES 2.0 THEOREM OF WIENER- KHINTCHINE An important technique in the study of deterministic signals consists in using harmonic functions to gain the spectral

More information

FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES

FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES Proceedings of the International Conference on Mechanical Engineering 2 (ICME2) 8-2 December 2, Dhaka, Bangladesh ICME-TH-6 FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES

More information

Model Reduction, Centering, and the Karhunen-Loeve Expansion

Model Reduction, Centering, and the Karhunen-Loeve Expansion Model Reduction, Centering, and the Karhunen-Loeve Expansion Sonja Glavaški, Jerrold E. Marsden, and Richard M. Murray 1 Control and Dynamical Systems, 17-81 California Institute of Technology Pasadena,

More information

Detailed Outline, M E 521: Foundations of Fluid Mechanics I

Detailed Outline, M E 521: Foundations of Fluid Mechanics I Detailed Outline, M E 521: Foundations of Fluid Mechanics I I. Introduction and Review A. Notation 1. Vectors 2. Second-order tensors 3. Volume vs. velocity 4. Del operator B. Chapter 1: Review of Basic

More information