[MCEN 5228]: Project report: Markov Chain Monte Carlo method with Approximate Bayesian Computation

Size: px
Start display at page:

Download "[MCEN 5228]: Project report: Markov Chain Monte Carlo method with Approximate Bayesian Computation"

Transcription

1 [MCEN 228]: Project report: Markov Chain Monte Carlo method with Approximate Bayesian Computation Olga Doronina December 2, 217 Contents 1 Introduction 1 2 Background Autonomic Closure (AC) Approximate Bayesian Computation (ABC) Approximate Bayesian Computation Autonomic Closure (ABC-AC) A Priori testing Computational expence and requared improvements Monte Carlo Markov Chain without likelihood ABC-MCMC algorithm Results Problems Improved Markov Chain Monte Carlo Improved MCMC algorithm Results Summary, conclusion, and future plans 17 1 Introduction Despite the increasing ubiquity of large eddy simulation (LES) in engineering research, accuracy remains limited by the fidelity with which unresolved small-scale physics are modeled. Due to the use of grid-scale filtering in nearly all practical LES, such models are commonly termed subgrid-scale (SGS) models. In order to improve upon Smagorinsky-based models, an autonomic closure approach was recently proposed by King et al [1]. In autonomic closure, test scale filtering is used to provide training data that can be used to determine unknown coefficients in the model for the unclosed stresses. In this sense, autonomic closure can be considered a data-driven turbulence closure, except that the training data are provided internally to the simulation rather than externally from experimental or higher fidelity DNS data. The resulting relation can be then applied at the LES grid scale to achieve closure. 1

2 We can consider the inverse problem of finding the model parameters given the training data at the test scale. To estimate model parameters we use the Approximate Bayesian Computation (ABC) approach [2]. ABC approximates the posterior distribution by sampling model parameters from prior distributions and compare model outcomes (or data) with observed truth data. The initial sampling technique is sampling from a uniform grid in parameter space, which is inefficient for a high number of parameters. An implementation of a Monte Carlo Markov Chain sampling algorithm can significantly reduce the number of required computations. In this paper, we provide the necessary background information of autonomic closure using the ABC method and a priori testing results for sampling from uniform grid. Then we outline the initial Markov Chain Monte Carlo (MCMC) sampling algorithm and show its a priori testing results. Finally, we consider Improved Markov Chain Monte Carlo (IMCMC) and show its a priori testing results. 2 Background Coarse-graining of the Navier Stokes equations using a low pass filter at scale gives the LES equations for an incompressible flow, which are written as [3] ũ i x i =, ũ i t + ũ ũ i j = p + ν 2 ũ i τ, (1) x j x i x j x j x j where ũ i is the resolved scale velocity, p is the resolved scale pressure normalized by density, ν is the kinematic viscosity, and τ is the unclosed SGS stress tensor given by τ = ũ i u j ũ i ũ j. (2) Note that here, and in the following, ( ) denotes a low-pass filter at the grid scale, which is also often termed the LES scale since this is the finest scale represented when using the grid discretization as an implicit LES filter. The SGS stress term τ prevents closure and, in order to solve Eq. (1), an appropriate relation for τ must be found in terms of resolved scale quantities only. 2.1 Autonomic Closure (AC) Closure of Eq. (1) can be achieved by modeling the deviatoric part of the stress tensor σ = τ 1 3 τ kkδ, which can be written in terms of an unknown, high-dimensional, nonparametric functional F that takes as its arguments only quantities that can be expressed in terms of the resolved-scale strain rate, S, and rotation rate, R, tensors; namely [4] [ σ (x, t) σ F (x, t) = F S (x + x, t t ), R ] (x + x, t t ) x and t, (3) where the resolved scale strain and rotation rate tensors are given by S = 1 ( ũi + ũ ) j, R = 1 ( ũi ũ ) j. (4) 2 x j x i 2 x j x i The same functional can be used to write down the closure relation at a test scale, where >, as ] σ (x, t) σ F (x, t) = F [ S (x + x, t t ), R (x + x, t t ) x and t. () 2

3 The deviatoric test scale stress tensor is then given by σ = T 1 3 T kkδ where T = ũ i ũ j ũ i ũj represents the test scale stress tensor. The test scale strain and rotation rate tensors are written as ( ) ( ) S = 1 ũ i + ũ j, R = 1 ũ i ũ j. (6) 2 x j x i 2 x j x i Here, and in the following, ( ) denotes a low-pass filter at test scale. The functional F in Eqs. (3) and () can be written as the fifth-order, single point, single time, nonlinear model introduced by Pope [4], which is given for generic strain and rotation rate tensors, S and R [following similar definitions to those in Eqs. (4) and (6)] as F (S, R ) = 1 λ=1 C λ G (λ), (7) where C λ are coefficients that can depend on invariants of S, R, and their products up to sixth order. The tensor bases G (λ) are formed from products of S and R up to fifth order, namely [4] G (1) = S, G (6) = S ik R kl R lj + R ik R kl S lj 2 3 δ S kl R lm R mk, G (2) = S ik R kj R ik S kj, G (7) = S ik S kl R lm R mj + R ik R kl S lm S mj 2 3 δ S kl S lm R mn R nk, G (3) = S ik S kj 1 3 δ S kl S kl, G (8) = S ik R kl S lm S mj S ik S kl R lm S mj, G (4) = R ik R kj 1 3 δ R kl R kl, G (9) = R ik S kl R lm R mj R ik R kl S lm S mj, G () = S ik S kl R lj R ik S kl S lj, G (1) = R ik S kl S lm R mn R nj R ik R kl S lm S mn R nj. In order to obtain G (λ) and Ĝ(λ) at the LES and test scales, respectively, S and R are replaced by the appropriate LES or test scale values of the strain and rotation rate tensors [as given in Eqs. (4) and (6)]. At the test scale, both the left and right hand sides of Eq. () are known, and thus the model parameters of F can be determined through an appropriate inversion technique. Once F is known at the test scale, it is then projected to the grid scale. The resulting closure approach is similar to dynamic versions of classical closures such as the Smagorinsky model [, 6] and to scale-similarity models such as that by Bardina et al.[7], except that the relation F is high dimensional and nonparametric. 2.2 Approximate Bayesian Computation (ABC) In King et al. [1], optimization and a least squares technique were used to invert Eq. () and solve for the unknown coefficients in the Volterra series formulation of F. However, the inversion process was memory intensive and only highly truncated forms of F were possible. Alternatively, ABC can be used to determine F. ABC is based on Bayes theorem, but instead of computing the likelihood function to determine the true posterior, it provides an approximation to the posterior distribution using an ad hoc distance function [2]. In general terms, ABC methods sample model parameters from prior distributions and compare model outcomes (or data) D with observed truth data D, which may come from experiments or a higher fidelity model. In order to reduce the computational expense, instead of full observed data D one can use summary statistics S(D), such as a mean, standard deviation, or full probability density function (pdf). Model statistics S (D ) can then be compared with the truth statistic S using a statistical distance ρ(s, S), where the distance function ρ may be a Kullback-Leibler divergence, Hellinger distance, or 3

4 simply a mean-square error. If S and S are similar to within some specified tolerance ɛ, then the sampled parameter values are retained and collected in an N-dimensional joint pdf, termed the posterior, where N is the number of unknown model parameters. From the maximum a posteriori probability (MAP), mean, or other characteristic statistic of the posterior distribution, a single set of parameters can be selected that gives the best agreement with the truth data. 2.3 Approximate Bayesian Computation Autonomic Closure (ABC-AC) Using concepts from autonomic closure and ABC, we can combine the following closure approach, denoted ABC-AC, at a particular time t. Here the prior time steps are neglected for simplicity; the ABC-AC approach is easily extended to include information at earlier times. Note that in the following, we assume that an appropriate relation containing a set of N unknown coefficients has already been selected for F. Moreover, we also assume that an N-dimensional prior joint pdf has been formulated as an estimate of the distribution of the unknown coefficients; typically, these priors are formulated as uniform distributions. The steps involved in application of the ABC-AC approach to closure of the LES equations are and denoted as Algorithm 1: 1. Filter resolved scale quantities ũ i and p in order to obtain test scale quantities ũ i and p. 2. Compute test scale deviatoric stresses σ. 3. Using σ, evaluate the truth statistic S; in the present case this statistic is the pdf of σ. 4. Sample the prior to obtain one possible realization of F and compute σ F.. Using σ F, evaluate the statistic SF using data from M training points. Note that M need not be (and indeed should not be) equal to the full size of the training data set. 6. If S and S F are in agreement to within some specified tolerance ɛ, retain the sample of N parameters in a new joint pdf. 7. Return to step 4 and repeat. This process is repeated a total P times until a reasonable estimate is obtained for the posterior. 8. From the estimated posterior, choose the modal value of the parameters; these parameters then give a statisticallyaccurate estimate for F. 9. Apply F at the LES scale to achieve closure. 2.4 A Priori testing A Priori testing is fundamental testing approach based on direct comparison between σ (x, t) and σ F (x, t) [3]. Such a comparison needs data at high spatial resolution that are sufficient to resolve the SGS range. σ (x, t) is evaluated based on its definition σ = τ 1 3 τ kkδ and Eq. (2), and σ F (x, t) is modeled using F with estimated parameters and filtered data. In the following, a priori tests of the ABC-AC approach are performed using pseudospectral HIT DNS data at Re λ = 433 from the Johns Hopkins Turbulence Database [8]. We outline two simplified formulations of ABC-AC where, as a validation test, we ensure that for a first-order simplification of the closure relation in Eq. (7), the approach can recover the coefficient C S used in the Smagorinsky model. second-order truncation of Eq. (7). Then we obtain coefficients from a 4

5 Both first and second order versions of the full model in Eq. (7) are tested here, giving the test-scale representations σ F = C 1 S [1st order], σ F = C 1 S + C 2 ( Sik Rkj Rik Skj ) + C 3 ( Sik Skj 1 3 δ Skl Slk ) (8) [2nd order]. (9) Note that in the second order formulation, C 4 = in order to satisfy requirements on material frame indifference [9]. Based on the formulation of the classical Smagorinsky model, it can be shown that C 1 = 2(C S ) 2 S where CS is the Smagorinsky coefficient and S ) 1/2 (2 S S. In order to facilitate comparisons with prior work, we similarly rewrite Eqs. (8) and (9) in terms of C S as σ F = 2(C S ) 2 S S [1st order], σ F = 2(C S ) 2 S S + C 2 2 ( Sik Rkj Rik Skj ) + C 3 2 ( Sik Skj 1 ) 3 δ Skl Slk (1) [2nd order]. (11) The test filtering required in these a priori tests is accomplished using spectrally sharp filtering. Figure 1 shows example velocity fields at the full DNS resolution, as well as at filtered LES and test scales. This figure also shows deviatoric SGS stress fields at the LES scale, denoted σ, for this data. It should be noted that the true expected value of C S from the data can be obtained from the relation C 2 S = [ ε S 3 ], where ε = 2νS S is the true kinetic energy dissipation rate. Using this relation, the data give C S =.22. In order for the ABC-AC approach to be deemed successful, it should recover this value for C S. The statistics used in the ABC analysis are pdfs of the test scale deviatoric stresses σ (as shown in Figure 2), which are denoted S since there is a pdf for each (i, j) component of the stress tensor. The prior distribution for C S is taken to be a uniform distribution between and.4. The sampled parameter value of C S is accepted with tolerance ɛ if i,j j i ρ(s F, S ) ɛ, where the summation is over all i and j such that j i, giving six independent terms in the summation; this summation approach is necessary since the stress tensors are symmetric and the terms with i j should not be double-counted in the combined distance metric. The statistical distance ρ(s F, S ) can be calculated many different ways. Here we show results using the Kullback- Leibler (KL) divergence. The KL divergence is given by ρ(s F, S ) = S ln S ln S F. It is emphasized that, in the present tests, S represents the pdf of σ and S F which are computed at the test scale. represents the pdf of σf, both of For the first order model, Figure 3 shows how the distance ρ(s F, S ) depends on C S for P = 1 samples of C S from its uniform prior, using a tolerance of ɛ = 2. The parameter value resulting in the minimum distance is close to the true value C S =.22. More specifically, the values obtained are C S.216. This value of C S determined at

6 6 v ṽ ṽ y x x x (a) Velocity fields at the full DNS resolution, and at LES and test scales (left to right). 6 σ 11 σ 12 σ y x x x.2 (b) SGS deviatoric stress (σ ) fields at the LES scale. Figure 1: Example velocity fields and SGS stresses σ at the LES scale for pseudospectral HIT data [8] used in a priori testing LES test pdf σ 11, σ 11 σ 12, σ 12 σ 13, σ 13 Figure 2: Probability density functions of the deviatoric stresses at LES (red lines) and test (green lines) scales, denoted σ and σ, respectively. the test filter scale can then be applied at the LES (i.e., grid) scale to approximate the unclosed stresses σ, namely σ F = 2(C S ) 2 S S. Figure 4 shows the resulting pdfs of σ F and σ, revealing reasonable agreement between the modeled and true stresses at the LES scale. A similar analysis for the second order model in Eq. (11) gives the posterior pdfs shown in Figure. In order to facilitate visualization of the three dimensional posterior, marginalized joint pdfs over one and two parameters are shown for each of C S, C 2 and C 3. Both the mode and mean of the marginal pdf for C S show that, once again, the 6

7 2 i,j ρ(sf, S ) C s Figure 3: Accepted values for the C S parameter in the first order model and corresponding statistical distances. 1 1 true modeled dist 1 1 pdf σ 11 σ 12 σ 13 Figure 4: Probability density functions of stresses σ F from the one-parameter first order model in Eq. (1) at the LES scale (green lines) and the true LES scale stresses σ from the DNS (red lines). ABC approach provides a value of C S close to.2. The marginal pdf for C 2 is bimodal with peaks at C 2 = ±.1; this indicates that the sign of C 2 is of no importance compared to the magnitude. Finally, the marginal pdf of C 3 peaks near, indicating that this term is of negligible importance compared to the other two terms in the second order closure relation. Using the values of C i that give the minimum distance in the statistics, the second order model parameters at the test scale are found to be C s =.18, C 2 =.88, C 3 =.1. These values can then be applied at the LES scale to give the pdfs of σ F at the LES scale shown in Figure 6. Once again, the second order model gives close agreement between the modeled and true stresses. 7

8 C s C mean max C 3 Figure : Marginal and joint probability density functions of accepted values of C S, C 2, and C 3 for the second order model in Eq. (11) at the test scale. Dashed green lines show the mean of each marginal pdf, and dashed red lines show the location of the MAP. 1 1 true modeled dist 1 1 pdf σ 11 σ 12 σ 13 Figure 6: Probability density functions of stresses σ F from the three-parameter second order model in Eq. (11) at the LES scale (green lines) and the true LES scale stresses σ from the DNS (red lines). 8

9 2. Computational expence and requared improvements The current realization of the ABC-AC algorithm samples model parameters from a uniform distribution (since we do not have any prior information about unknown parameters) for each parameter. The full nonlinear model F (Eq. (7)) has fifth order and ten unknown parameters, which potentially makes the prior distribution to be a 1-dimensional uniform grid. There is one problem with large-dimensional spaces mensioned by Tarantola [1]: they tend to be terribly empty. That is the probability of sampling from uniform distribution the (maximum-size) hypersphere inscribed in a hypercube rapidly decreases to zero when the dimension of the space grows. Even having only 1 points per dimension in the prior uniform grid makes the problem prohibitively expansive. Table 1 shows the estimated time of computation on one core. Model F Computational time # sampled points Order # parameters N iteration/s time on 1 core 1st order [it/s] 1.9 [s] 2nd order (without C 4 ) [it/s] 8. [h] 2nd order [it/s] 92 [h] 3rd order [years] 4th order th order Table 1: The estimated time of computation on one core with 1 points per dimension in prior uniform grid. The number of accepted parameters, which in fact form the posterior distribution, is only a small part of sampled parameters. For example, for the second order model with three parameters (Eq. (11)) only about 2% of the sampled points were accepted in the posterior distribution (Figure ) and this number rapidly decreases as the number of parameters grows. However, this problem can be solved, and the sampling technique can be significantly improved, by using Monte Carlo Markov Chain (MCMC) algorithm. 3 Monte Carlo Markov Chain without likelihood 3.1 ABC-MCMC algorithm Since ABC does not evaluate a likelihood function, we need to use the Monte Carlo Markov Chain method without a likelihood [11], which is based on the Metropolis Hastings algorithm, however, no likelihoods are used or estimated. [11] provided the following steps in the algorithm (instead of steps 4-7 in Algorithm 1): 4. If now at θ, propose a move to θ according to a transition kernel q(θ θ ).. Generate σ F using model F with parameters θ and evaluate the statistic S F using data from M training points. 6. If ρ(s, S F ) < ε, go to 7, and otherwise stay at θ and return to Calculate h = h(θ, θ ) = min ( 1, π(θ )q(θ ) θ) π(θ)q(θ θ ) Accept θ with probability h otherwise stay at θ, then return to 4. 9

10 The algorithm also can be effectively parallelized on large number of processors [12]. Choosing transitional kernel q(θ θ ) to be a gaussian with prescribed constant variance and current parameter θ as mean value, we have q(θ θ ) = q(θ θ). Therefore h, in step 4, depends only on the prior distribution.in our case, we do not have any prior information about the possible distribution of parameters, thus π(θ) is uniform and equal to π(θ ) for any θ. This leads to h = 1 for any θ and the algorithm reduces to a rejection method with correlated outputs. But since all new samples appear around accepted parameters, almost all of them are accepted, whereas for ABC algorithm without MCMC and 3 parameters model only about 1% of the sampled parameters were accepted. The percent of accepted parameters in ABC-MCMC depends on the variance in the transition kernel, that is the smaller variance leads to a larger number of accepted parameters. Thus the ABC-MCMC requires less evaluations of modeled deviatoric stresses σ F, statistic SF on this data, and distance function ρ(s, S F ) to get the same number of accepted parameters in the posterior distribution. 3.2 Results To test our implementation of MCMC sampling algorithm we use the same a priori testing with data described in Section 2.4 and first and second order models given by Eqs. (1) and (11) correspondingly. The transition kernel q(θ θ ) used below is a gaussian distribution with constant prescribed variance for each parameter. The variance is set to be 1/2 of initial parameters range, that is.7, for parameter C S. First order model. For the first order model, Figure 7 shows how the distance ρ(s F, S ) depends on C S for P = 1 accepted samples of C S using MCMC sampling and tolerance of ɛ = 2. The parameter value resulting in the minimum distance is the same as parameter recovered using uniform grid sampling in Section 2.4. More specifically, the estimated value is C S.216. Figure 8 shows the resulting pdfs of σ F and σ, revealing reasonable agreement between the modeled and true stresses at the LES scale. The advantage of the ABC-MCMC algorithm is it s efficiency. The number of accepted parameters is 1, which is 94% of the total number of evaluations of modeled stresses σ F, statistic SF, and distance function ρ(s, S F ). 2 2 i,j ρ(sf, S ) C S Figure 7: Accepted values for the C S parameter in the first order model and corresponding statistical distances. 1

11 1 1 true modeled dist 1 1 pdf σ 11 σ 12 σ 13 Figure 8: Probability density functions of stresses σ F from the one-parameter first order model in Eq. (1) at the LES scale (green lines) and the true LES scale stresses σ from the DNS (red lines). Second order model with 3 parameters. A similar analysis for the second order model in Eq. (11) gives the posterior pdfs shown in Figure 9. For better visualization of the three dimensional posterior, the marginal pdfs shown on the diagonal subplots and marginalized joint pdfs over one parameter are on off-diagonal subplots. The MAP values of marginal pdfs are C S =.21, C 2 =.73, C 3 =.4. Using the values of C i that give the minimum distance in the statistics, the second order model parameters at the test scale are found to be C s =.18, C 2 =.88, C 3 =.2. These values can then be applied at the LES scale to give the pdfs of σ F at the LES scale shown in Figure 1. Figure 1 also shows the pdf resulting from parameters estimated as MAP of posterior pdf, C s =.22, C 2 =.37, C 3 =.3. Once again, the second order model gives close agreement between the modeled and true stresses. The number of accepted parameters was set to be 2 1, the same as for ABC with uniform grid sampling, which is 76% of the total number of samples. Thus, the total number of evaluations of modeled stresses σ F, statistic S F, and distance function ρ(s, S F ) is four times smaller than for ABC with uniform grid sampling. Table 2 provides time of computation on one core using the MCMC sampling algorithm. We also implemented the ABC-MCMC algorithm in parallel using separate Markov Chain for each processor. Model F Computational time # sampled # accepted Order # parameters iteration/s time on 1 core 1st order (94%) [it/s] 2[s] 2nd order (79%) 2 [it/s] 2 [h] Table 2: Time of computation on one core using MCMC sampling algorithm. 11

12 C S C mean max C 3 Figure 9: Marginal and joint probability density functions of accepted values of C S, C 2, and C 3 for the second order model in Eq. (11) at the test scale. Dashed green lines show the mean of each marginal pdf, and dashed red lines show the location of the MAP true modeled joint modeled dist pdf σ 11 σ 12 σ 13 Figure 1: Probability density functions of stresses σ F from the three-parameter second order model in Eq. (11) at the LES scale (green lines) and the true LES scale stresses σ from the DNS (red lines). 12

13 3.3 Problems Some problems were noticed (see [13]) in MCMC algorithm described above. One of them is the fixed acceptance threshold value ɛ. The choice of ɛ is important as too large a tolerance interval results in a chain being dominated by the prior π(θ). On the other hand, too small a value leads to a very small acceptance rate. The other problem is the initializing step. To start the chain, the algorithm need to find the initial accepted parameter θ. Since the area of accepted parameters tends to be smaller as dimensionality grows, the time the initialization step takes can increase dramatically with the number of parameters. To solve these problems Wagman et al. [13] suggested an improved version of the MCMC algorithm. 4 Improved Markov Chain Monte Carlo 4.1 Improved MCMC algorithm The improved MCMC (IMCMC) algorithm proposed by Wagman et al. [13] has a calibration step. In this step it performs a series of n simulations, where parameters at each time are randomly sampled from their prior π(θ) to obtain p n (ρ θ, S F ), an approximation of the distances distribution π(ρ θ, S F ). Using this calibration step, we can define a tolerance level x and a threshold distance ɛ such that P (ρ < ɛ) = x. We should then be able to use any simulation for which ρ < ɛ as a starting point for the Markov chain. These n simulations are also used to adjust the transition kernel q(θ θ ). In our case, q is set to be a gaussian distribution with standart deviation equal to the standard deviation of the retained parameters. We did not consider the statistics modification suggested by Wagman et al. [13], therefore we have a slightly simplified version of the algorithm provided in [11], that is 1. Perform n simulations with parameters θ randomly drawn from their priors π(θ ), and each time compute their associated statistics S F. 2. Fix tolerance level x and estimate threshold distance ɛ from p n (ρ θ, S F ) suth that P (ρ < ɛ) = x. Set the proposal range of the parameters for the transition kernel q(θ θ ) on the basis of the parameters variability among the xn retained simulations. 3. Start an MCMC chain of total length P from a position θ randomly chosen from the xn retained simulations. Set i =. 4. If now at θ, propose a move to θ according to a transition kernel q(θ θ ). Increment i.. Generate σ F using model F with parameters θ and evaluate the statistic S F using data from M training points. 6. If ρ(s, S F ) < ε, go to 7, and otherwise stay at θ and return to Calculate h = h(θ, θ ) = min ( 1, π(θ )q(θ ) θ) π(θ)q(θ θ ) Accept θ with probability h otherwise stay at θ, then return to If i < s go to 4. Other possible improvement is modification in parameter estimation. Wagman et al. [13] proposed to estimate parameters on a subsample of size t with the smallest distances ρ generated by the Markov chain and to perform a 13

14 local regression adjustment where samples are weighted by their associated ρ i -values. These steps can greatly improve the quality of the estimation. This approach allows the chain to have a large acceptance rate, while making the final estimation not too sensitive to the prior due to the regression adjustment step. 4.2 Results First order model. The calibration step used n = 1 simulations and x =.1 and, as result, it set threshold value ɛ 1 (see Figure 11). The Markov chain used P = 9 steps and got the same parameter value as parameter recovered using uniform grid sampling in Section 2.4 and the MCMC algorithm in Section 3.2. More specifically, the estimated value is C S.216. Figure 12 shows the resulting pdfs of σ F and σ, revealing reasonable agreement between the modeled and true stresses at the LES scale. 2 2 i,j ρ(sf, S ) C S Figure 11: Accepted values for the C S parameter in the first order model and corresponding statistical distances. 1 1 true modeled dist 1 1 pdf σ 11 σ 12 σ 13 Figure 12: Probability density functions of stresses σ F from the one-parameter first order model in Eq. (1) at the LES scale (green lines) and the true LES scale stresses σ from the DNS (red lines). Second order model with 3 parameters. The calibration step used n = 1 4 simulations with tolerance level x =.1 and, as result, it set threshold value ɛ 21. The Markov chain used P = 1 steps and all of them were accepted. Therefore, 1/11 = 9% of all evaluations of modeled σ, statistics S F and distance ρ led to accepted parameters, which makes it more efficient then even MCMC. 14

15 F, S ) depends on each of three parameters C, C and C. Using the values Figure 13 shows how the distance ρ(s 1 2 S of Ci that give the minimum distance in the statistics, the second order model parameters at the test scale are found to be Cs =.183, C2 =.86, C3 =.29. which is close to the parameters estimated earlier. The marginal posterior pdfs are shown on Figure 14. The MAP values of marginal pdfs are CS =.217, C2 =.79, C3 =.22. We can see on Figure 14 that the marginal pdf of C2 is not symmetric. This could happen because of too small a standard deviation in the kernel transition for the second parameter, so the algorithm could not find the second maximum.however this fact did not influence our resulting pdfs because, as was seen in the previous results, the sign of C2 is of no importance compared to the magnitude. F at the LES scale shown in Figure 1. These values can then be applied at the LES scale to give the pdfs of σ Figure 1 also shows the pdf resulting from the parameters estimated as the MAP of the posterior pdf, Cs =.21, C2 =.67, C3 =.27. We can see that these estimated parameters give a better agreement to the true stresses calculated from the DNS data CS.3 1 P i,j 1 P i,j 1 P i,j 1 F ρ(s, S ) 2 F ρ(s, S ) 2 F ρ(s, S ) 2.1. C C3.1 Figure 13: Accepted values for the CS, C1, C2 parameters in the second order model and corresponding statistical distances. 1

16 C S C mean max C 3 Figure 14: Marginal and joint probability density functions of accepted values of C S, C 2, and C 3 for the second order model in Eq. (11) at the test scale. Dashed green lines show the mean of each marginal pdf, and dashed red lines show the location of the MAP true modeled joint modeled dist pdf σ 11 σ 12 σ 13 Figure 1: Probability density functions of stresses σ F from the three-parameter second order model in Eq. (11) at the LES scale (green lines) and the true LES scale stresses σ from the DNS (red lines). 16

17 Summary, conclusion, and future plans.in this project we implemented the ABC-MCMC algorithm, which reduced the number of function evaluations and the time of computation by a factor of four without introducing any additional bias in the estimated parameters. We also implemented an improved MCMC algorithm, which allows one to automatically adjust the initial treshold ɛ and transitional kernel q(θ θ ). This improvement reduced the number of function evaluations even more and improved the agreement between the truth and modeled pdfs. Moreover, both algorithms were validated using the results of ABC with sampling from a uniform grid. In the future these two algorithms can be considered more deeply. We can adjust the algorithms to better find both peaks of the pdf of the second parameter, find the best acceptance level for x, and to find the number of simulations needed in calibration step for n. We also can improve the estimation technique using a subsample of size t with the smallest distances ρ generated by the Markov chain. References [1] King, R. N., Hamlington, P. E., and Dahm, W. J., Autonomic closure for turbulence simulations, Physical Review E, Vol. 93, No. 3, 216, pp [2] Sunnaker, M., Busetto, A. G., Numminen, E., Corander, J., Foll, M., and Dessimoz, C., Approximate Bayesian Computation, PLoS Computational Biology, Vol. 9, No. 1, Jan. 213, pp. e1283. [3] Meneveau, C. and Katz, J., Scale-invariance and turbulence models for large-eddy simulation, Annu. Rev. Fluid Mech., Vol. 32, 2, pp [4] Pope, S. B., A more general effective-viscosity hypothesis, Journal of Fluid Mechanics, Vol. 72, No. 2, 197, pp [] Germano, M., Piomelli, U., Moin, P., and Cabot, W. H., A dynamic subgridscale eddy viscosity model, Phys. Fluids A, Vol. 3, 1991, pp [6] Lilly, D. K., A proposed modification of the Germano subgrid-scale closure method, Phys. Fluids A, Vol. 4, No. 3, 1992, pp [7] Bardina, J., Ferziger, J., and Reynolds, W. C., Improved subgrid scale models for Large Eddy Simulation, AIAA paper, Vol. No , 198. [8] Li, Y., Perlman, E., Wan, M., Yang, Y., Meneveau, C., Burns, R., Chen, S., Szalay, A., and Eyink, G., A public turbulence database cluster and applications to study Lagrangian evolution of velocity increments in turbulence, Journal of Turbulence,, No. 9, 28, pp. N31. [9] Speziale, C. G., Comments on the material frame-indifferencecontroversy, Physical Review A, Vol. 36, No. 9, 1987, pp [1] Tarantola, A., Inverse problem theory and methods for model parameter estimation, SIAM, 2. [11] Marjoram, P., Molitor, J., Plagnol, V., and Tavar, S., Markov chain Monte Carlo without likelihoods, Proceedings of the National Academy of Sciences, Vol. 1, No. 26, 23, pp [12] Sadegh, M. and Vrugt, J. A., Approximate bayesian computation using markov chain monte carlo simulation: Dream (abc), Water Resources Research, Vol., No. 8, 214, pp

18 [13] Wegmann, D., Leuenberger, C., and Excoffier, L., Efficient approximate Bayesian computation coupled with Markov chain Monte Carlo without likelihood, Genetics, Vol. 182, No. 4, 29, pp [14] Beaumont, M. A., Cornuet, J.-M., Marin, J.-M., and Robert, C. P., Adaptive approximate Bayesian computation, Biometrika, Vol. 96, No. 4, 29, pp [1] Ishida, E., Vitenti, S., Penna-Lima, M., Cisewski, J., de Souza, R., Trindade, A., Cameron, E., Busti, V., collaboration, C., et al., cosmoabc: likelihood-free inference via population Monte Carlo approximate Bayesian computation, Astronomy and Computing, Vol. 13, 21, pp

A NEW AUTONOMIC CLOSURE FOR LARGE EDDY SIMULATIONS

A NEW AUTONOMIC CLOSURE FOR LARGE EDDY SIMULATIONS June 3 - July 3, 25 Melbourne, Australia 9 B-3 A NEW AUTONOMIC CLOSURE FOR LARGE EDDY SIMULATIONS Ryan N. King Department of Mechanical Engineering University of Colorado Boulder, CO, 839, USA ryan.n.king@colorado.edu

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

Approximate Bayesian Computation: a simulation based approach to inference

Approximate Bayesian Computation: a simulation based approach to inference Approximate Bayesian Computation: a simulation based approach to inference Richard Wilkinson Simon Tavaré 2 Department of Probability and Statistics University of Sheffield 2 Department of Applied Mathematics

More information

LARGE EDDY SIMULATION OF MASS TRANSFER ACROSS AN AIR-WATER INTERFACE AT HIGH SCHMIDT NUMBERS

LARGE EDDY SIMULATION OF MASS TRANSFER ACROSS AN AIR-WATER INTERFACE AT HIGH SCHMIDT NUMBERS The 6th ASME-JSME Thermal Engineering Joint Conference March 6-, 3 TED-AJ3-3 LARGE EDDY SIMULATION OF MASS TRANSFER ACROSS AN AIR-WATER INTERFACE AT HIGH SCHMIDT NUMBERS Akihiko Mitsuishi, Yosuke Hasegawa,

More information

Modelling of turbulent flows: RANS and LES

Modelling of turbulent flows: RANS and LES Modelling of turbulent flows: RANS and LES Turbulenzmodelle in der Strömungsmechanik: RANS und LES Markus Uhlmann Institut für Hydromechanik Karlsruher Institut für Technologie www.ifh.kit.edu SS 2012

More information

A dynamic global-coefficient subgrid-scale eddy-viscosity model for large-eddy simulation in complex geometries

A dynamic global-coefficient subgrid-scale eddy-viscosity model for large-eddy simulation in complex geometries Center for Turbulence Research Annual Research Briefs 2006 41 A dynamic global-coefficient subgrid-scale eddy-viscosity model for large-eddy simulation in complex geometries By D. You AND P. Moin 1. Motivation

More information

Likelihood-free MCMC

Likelihood-free MCMC Bayesian inference for stable distributions with applications in finance Department of Mathematics University of Leicester September 2, 2011 MSc project final presentation Outline 1 2 3 4 Classical Monte

More information

Predicting natural transition using large eddy simulation

Predicting natural transition using large eddy simulation Center for Turbulence Research Annual Research Briefs 2011 97 Predicting natural transition using large eddy simulation By T. Sayadi AND P. Moin 1. Motivation and objectives Transition has a big impact

More information

Subgrid-Scale Models for Compressible Large-Eddy Simulations

Subgrid-Scale Models for Compressible Large-Eddy Simulations Theoret. Comput. Fluid Dynamics (000 13: 361 376 Theoretical and Computational Fluid Dynamics Springer-Verlag 000 Subgrid-Scale Models for Compressible Large-Eddy Simulations M. Pino Martín Department

More information

Fast Likelihood-Free Inference via Bayesian Optimization

Fast Likelihood-Free Inference via Bayesian Optimization Fast Likelihood-Free Inference via Bayesian Optimization Michael Gutmann https://sites.google.com/site/michaelgutmann University of Helsinki Aalto University Helsinki Institute for Information Technology

More information

Monte Carlo in Bayesian Statistics

Monte Carlo in Bayesian Statistics Monte Carlo in Bayesian Statistics Matthew Thomas SAMBa - University of Bath m.l.thomas@bath.ac.uk December 4, 2014 Matthew Thomas (SAMBa) Monte Carlo in Bayesian Statistics December 4, 2014 1 / 16 Overview

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

Approximate Bayesian Computation for Astrostatistics

Approximate Bayesian Computation for Astrostatistics Approximate Bayesian Computation for Astrostatistics Jessi Cisewski Department of Statistics Yale University October 24, 2016 SAMSI Undergraduate Workshop Our goals Introduction to Bayesian methods Likelihoods,

More information

Tutorial on ABC Algorithms

Tutorial on ABC Algorithms Tutorial on ABC Algorithms Dr Chris Drovandi Queensland University of Technology, Australia c.drovandi@qut.edu.au July 3, 2014 Notation Model parameter θ with prior π(θ) Likelihood is f(ý θ) with observed

More information

On the Euler rotation angle and axis of a subgrid-scale stress model

On the Euler rotation angle and axis of a subgrid-scale stress model Center for Turbulence Research Proceedings of the Summer Program 212 117 On the Euler rotation angle and axis of a subgrid-scale stress model By M. Saeedi, B.-C. Wang AND S. T. Bose In this research, geometrical

More information

Approximate Bayesian Computation

Approximate Bayesian Computation Approximate Bayesian Computation Michael Gutmann https://sites.google.com/site/michaelgutmann University of Helsinki and Aalto University 1st December 2015 Content Two parts: 1. The basics of approximate

More information

cfl Copyright by Fotini V. Katopodes 2000 All rights reserved.

cfl Copyright by Fotini V. Katopodes 2000 All rights reserved. A theory for the subfilter-scale model in large-eddy simulation Fotini V. Katopodes, Robert L. Street, Joel H. Ferziger March, 2000 Technical Report 2000-K1 Environmental Fluid Mechanics Laboratory Stanford,

More information

On the relationship between the mean flow and subgrid stresses in large eddy simulation of turbulent shear flows

On the relationship between the mean flow and subgrid stresses in large eddy simulation of turbulent shear flows PHYSICS OF FLUIDS VOLUME 11, NUMBER 5 MAY 1999 On the relationship between the mean flow and subgrid stresses in large eddy simulation of turbulent shear flows L. Shao a) Laboratoire de Mécanique des Fluides

More information

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical Outline Geurts Book Department of Fluid Mechanics, Budapest University of Technology and Economics Spring 2013 Outline Outline Geurts Book 1 Geurts Book Origin This lecture is strongly based on the book:

More information

Reliability of LES in complex applications

Reliability of LES in complex applications Reliability of LES in complex applications Bernard J. Geurts Multiscale Modeling and Simulation (Twente) Anisotropic Turbulence (Eindhoven) DESIDER Symposium Corfu, June 7-8, 27 Sample of complex flow

More information

Large eddy simulation of turbulent flow over a backward-facing step: effect of inflow conditions

Large eddy simulation of turbulent flow over a backward-facing step: effect of inflow conditions June 30 - July 3, 2015 Melbourne, Australia 9 P-26 Large eddy simulation of turbulent flow over a backward-facing step: effect of inflow conditions Jungwoo Kim Department of Mechanical System Design Engineering

More information

An Introduction to Theories of Turbulence. James Glimm Stony Brook University

An Introduction to Theories of Turbulence. James Glimm Stony Brook University An Introduction to Theories of Turbulence James Glimm Stony Brook University Topics not included (recent papers/theses, open for discussion during this visit) 1. Turbulent combustion 2. Turbulent mixing

More information

An improved velocity increment model based on Kolmogorov equation of filtered velocity

An improved velocity increment model based on Kolmogorov equation of filtered velocity An improved velocity increment model based on Kolmogorov equation of filtered velocity Le Fang, Liang Shao, Jean-Pierre Bertoglio, Guixiang X. Cui, Chun-Xiao Xu, Zhaoshun Zhang To cite this version: Le

More information

Introduction to Turbulence and Turbulence Modeling

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

More information

DNS, LES, and wall-modeled LES of separating flow over periodic hills

DNS, LES, and wall-modeled LES of separating flow over periodic hills Center for Turbulence Research Proceedings of the Summer Program 4 47 DNS, LES, and wall-modeled LES of separating flow over periodic hills By P. Balakumar, G. I. Park AND B. Pierce Separating flow in

More information

Mixing Models for Large-Eddy Simulation of Nonpremixed Turbulent Combustion

Mixing Models for Large-Eddy Simulation of Nonpremixed Turbulent Combustion S. M. debruynkops Lecturer J. J. Riley Professor Department of Mechanical Engineering, University of Washington, Box 35600, Seattle, WA 98195-600 Mixing Models for Large-Eddy Simulation of Nonpremixed

More information

Density Estimation. Seungjin Choi

Density Estimation. Seungjin Choi Density Estimation Seungjin Choi Department of Computer Science and Engineering Pohang University of Science and Technology 77 Cheongam-ro, Nam-gu, Pohang 37673, Korea seungjin@postech.ac.kr http://mlg.postech.ac.kr/

More information

Turbulence: Basic Physics and Engineering Modeling

Turbulence: Basic Physics and Engineering Modeling DEPARTMENT OF ENERGETICS Turbulence: Basic Physics and Engineering Modeling Numerical Heat Transfer Pietro Asinari, PhD Spring 2007, TOP UIC Program: The Master of Science Degree of the University of Illinois

More information

Introduction to Turbulence, its Numerical Modeling and Downscaling

Introduction to Turbulence, its Numerical Modeling and Downscaling 560.700: Applications of Science-Based Coupling of Models October, 2008 Introduction to Turbulence, its Numerical Modeling and Downscaling Charles Meneveau Department of Mechanical Engineering Center for

More information

Eulerian models. 2.1 Basic equations

Eulerian models. 2.1 Basic equations 2 Eulerian models In this chapter we give a short overview of the Eulerian techniques for modelling turbulent flows, transport and chemical reactions. We first present the basic Eulerian equations describing

More information

Fitting the Bartlett-Lewis rainfall model using Approximate Bayesian Computation

Fitting the Bartlett-Lewis rainfall model using Approximate Bayesian Computation 22nd International Congress on Modelling and Simulation, Hobart, Tasmania, Australia, 3 to 8 December 2017 mssanz.org.au/modsim2017 Fitting the Bartlett-Lewis rainfall model using Approximate Bayesian

More information

The Johns Hopkins Turbulence Databases (JHTDB)

The Johns Hopkins Turbulence Databases (JHTDB) The Johns Hopkins Turbulence Databases (JHTDB) HOMOGENEOUS BUOYANCY DRIVEN TURBULENCE DATA SET Data provenance: D. Livescu 1 Database Ingest and Web Services: C. Canada 1, K. Kalin 2, R. Burns 2 & IDIES

More information

43rd AIAA Aerospace Sciences Meeting and Exhibit, Jan 2005, Reno, Nevada

43rd AIAA Aerospace Sciences Meeting and Exhibit, Jan 2005, Reno, Nevada 43rd AIAA Aerospace Sciences Meeting and Exhibit, 10-13 Jan 2005, Reno, Nevada A Dynamic Procedure for the Lagrangian Averaged Navier-Stokes-α Model of Turbulent Flows Kamran Mohseni and Hongwu Zhao Aerospace

More information

model and its application to channel ow By K. B. Shah AND J. H. Ferziger

model and its application to channel ow By K. B. Shah AND J. H. Ferziger Center for Turbulence Research Annual Research Briefs 1995 73 A new non-eddy viscosity subgrid-scale model and its application to channel ow 1. Motivation and objectives By K. B. Shah AND J. H. Ferziger

More information

Subgrid-scale modeling of helicity and energy dissipation in helical turbulence

Subgrid-scale modeling of helicity and energy dissipation in helical turbulence Subgrid-scale modeling of helicity and energy dissipation in helical turbulence Yi Li, 1 Charles Meneveau, 1 Shiyi Chen, 1,2 and Gregory L. Eyink 3 1 Department of Mechanical Engineering and Center for

More information

Analysis and modelling of subgrid-scale motions in near-wall turbulence

Analysis and modelling of subgrid-scale motions in near-wall turbulence J. Fluid Mech. (1998), vol. 356, pp. 327 352. Printed in the United Kingdom c 1998 Cambridge University Press 327 Analysis and modelling of subgrid-scale motions in near-wall turbulence By CARLOS HÄRTEL

More information

Testing of a new mixed model for LES: the Leonard model supplemented by a dynamic Smagorinsky term

Testing of a new mixed model for LES: the Leonard model supplemented by a dynamic Smagorinsky term Center for Turbulence Research Proceedings of the Summer Program 1998 367 Testing of a new mixed model for LES: the Leonard model supplemented by a dynamic Smagorinsky term By G. S. Winckelmans 1,A.A.Wray

More information

Regularization modeling of turbulent mixing; sweeping the scales

Regularization modeling of turbulent mixing; sweeping the scales Regularization modeling of turbulent mixing; sweeping the scales Bernard J. Geurts Multiscale Modeling and Simulation (Twente) Anisotropic Turbulence (Eindhoven) D 2 HFest, July 22-28, 2007 Turbulence

More information

Dynamics of the Coarse-Grained Vorticity

Dynamics of the Coarse-Grained Vorticity (B) Dynamics of the Coarse-Grained Vorticity See T & L, Section 3.3 Since our interest is mainly in inertial-range turbulence dynamics, we shall consider first the equations of the coarse-grained vorticity.

More information

Approximate Bayesian Computation for the Stellar Initial Mass Function

Approximate Bayesian Computation for the Stellar Initial Mass Function Approximate Bayesian Computation for the Stellar Initial Mass Function Jessi Cisewski Department of Statistics Yale University SCMA6 Collaborators: Grant Weller (Savvysherpa), Chad Schafer (Carnegie Mellon),

More information

Lecture 14. Turbulent Combustion. We know what a turbulent flow is, when we see it! it is characterized by disorder, vorticity and mixing.

Lecture 14. Turbulent Combustion. We know what a turbulent flow is, when we see it! it is characterized by disorder, vorticity and mixing. Lecture 14 Turbulent Combustion 1 We know what a turbulent flow is, when we see it! it is characterized by disorder, vorticity and mixing. In a fluid flow, turbulence is characterized by fluctuations of

More information

The JHU Turbulence Databases (JHTDB)

The JHU Turbulence Databases (JHTDB) The JHU Turbulence Databases (JHTDB) TURBULENT CHANNEL FLOW DATA SET Data provenance: J. Graham 1, M. Lee 2, N. Malaya 2, R.D. Moser 2, G. Eyink 1 & C. Meneveau 1 Database ingest and Web Services: K. Kanov

More information

Bayesian Estimation of DSGE Models 1 Chapter 3: A Crash Course in Bayesian Inference

Bayesian Estimation of DSGE Models 1 Chapter 3: A Crash Course in Bayesian Inference 1 The views expressed in this paper are those of the authors and do not necessarily reflect the views of the Federal Reserve Board of Governors or the Federal Reserve System. Bayesian Estimation of DSGE

More information

A priori tests of one-equation LES modeling of rotating turbulence

A priori tests of one-equation LES modeling of rotating turbulence Journal of Turbulence Volume 8, No. 37, 2007 A priori tests of one-equation LES modeling of rotating turbulence HAO LU, CHRISTOPHER J. RUTLAND and LESLIE M. SMITH, Engine Research Center, Department of

More information

SUBGRID MODELS FOR LARGE EDDY SIMULATION: SCALAR FLUX, SCALAR DISSIPATION AND ENERGY DISSIPATION

SUBGRID MODELS FOR LARGE EDDY SIMULATION: SCALAR FLUX, SCALAR DISSIPATION AND ENERGY DISSIPATION SUBGRID MODELS FOR LARGE EDDY SIMULATION: SCALAR FLUX, SCALAR DISSIPATION AND ENERGY DISSIPATION By Sergei G. Chumakov A dissertation submitted in partial fulfillment of the requirements for the degree

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

Tutorial on Approximate Bayesian Computation

Tutorial on Approximate Bayesian Computation Tutorial on Approximate Bayesian Computation Michael Gutmann https://sites.google.com/site/michaelgutmann University of Helsinki Aalto University Helsinki Institute for Information Technology 16 May 2016

More information

BAYESIAN METHODS FOR VARIABLE SELECTION WITH APPLICATIONS TO HIGH-DIMENSIONAL DATA

BAYESIAN METHODS FOR VARIABLE SELECTION WITH APPLICATIONS TO HIGH-DIMENSIONAL DATA BAYESIAN METHODS FOR VARIABLE SELECTION WITH APPLICATIONS TO HIGH-DIMENSIONAL DATA Intro: Course Outline and Brief Intro to Marina Vannucci Rice University, USA PASI-CIMAT 04/28-30/2010 Marina Vannucci

More information

Multiscale Computation of Isotropic Homogeneous Turbulent Flow

Multiscale Computation of Isotropic Homogeneous Turbulent Flow Multiscale Computation of Isotropic Homogeneous Turbulent Flow Tom Hou, Danping Yang, and Hongyu Ran Abstract. In this article we perform a systematic multi-scale analysis and computation for incompressible

More information

Computers and Mathematics with Applications. Investigation of the LES WALE turbulence model within the lattice Boltzmann framework

Computers and Mathematics with Applications. Investigation of the LES WALE turbulence model within the lattice Boltzmann framework Computers and Mathematics with Applications 59 (2010) 2200 2214 Contents lists available at ScienceDirect Computers and Mathematics with Applications journal homepage: www.elsevier.com/locate/camwa Investigation

More information

Bayesian Semiparametric GARCH Models

Bayesian Semiparametric GARCH Models Bayesian Semiparametric GARCH Models Xibin (Bill) Zhang and Maxwell L. King Department of Econometrics and Business Statistics Faculty of Business and Economics xibin.zhang@monash.edu Quantitative Methods

More information

The Particle Filter. PD Dr. Rudolph Triebel Computer Vision Group. Machine Learning for Computer Vision

The Particle Filter. PD Dr. Rudolph Triebel Computer Vision Group. Machine Learning for Computer Vision The Particle Filter Non-parametric implementation of Bayes filter Represents the belief (posterior) random state samples. by a set of This representation is approximate. Can represent distributions that

More information

LES of turbulent shear flow and pressure driven flow on shallow continental shelves.

LES of turbulent shear flow and pressure driven flow on shallow continental shelves. LES of turbulent shear flow and pressure driven flow on shallow continental shelves. Guillaume Martinat,CCPO - Old Dominion University Chester Grosch, CCPO - Old Dominion University Ying Xu, Michigan State

More information

Bayesian Semiparametric GARCH Models

Bayesian Semiparametric GARCH Models Bayesian Semiparametric GARCH Models Xibin (Bill) Zhang and Maxwell L. King Department of Econometrics and Business Statistics Faculty of Business and Economics xibin.zhang@monash.edu Quantitative Methods

More information

Ensemble averaged dynamic modeling. By D. Carati 1,A.Wray 2 AND W. Cabot 3

Ensemble averaged dynamic modeling. By D. Carati 1,A.Wray 2 AND W. Cabot 3 Center for Turbulence Research Proceedings of the Summer Program 1996 237 Ensemble averaged dynamic modeling By D. Carati 1,A.Wray 2 AND W. Cabot 3 The possibility of using the information from simultaneous

More information

Unified turbulence models for LES and RANS, FDF and PDF simulations

Unified turbulence models for LES and RANS, FDF and PDF simulations Theor. Comput. Fluid Dyn. 27 21: 99 118 DOI 1.17/s162-6-36-8 ORIGINA ARTICE Stefan Heinz Unified turbulence models for ES and RANS, FDF and PDF simulations Received: 3 September 25 / Accepted: 18 July

More information

Mass Transfer in Turbulent Flow

Mass Transfer in Turbulent Flow Mass Transfer in Turbulent Flow ChEn 6603 References: S.. Pope. Turbulent Flows. Cambridge University Press, New York, 2000. D. C. Wilcox. Turbulence Modeling for CFD. DCW Industries, La Caada CA, 2000.

More information

Recent Advances in Bayesian Inference Techniques

Recent Advances in Bayesian Inference Techniques Recent Advances in Bayesian Inference Techniques Christopher M. Bishop Microsoft Research, Cambridge, U.K. research.microsoft.com/~cmbishop SIAM Conference on Data Mining, April 2004 Abstract Bayesian

More information

A scale-dependent dynamic model for large-eddy simulation: application to a neutral atmospheric boundary layer

A scale-dependent dynamic model for large-eddy simulation: application to a neutral atmospheric boundary layer J. Fluid Mech. (2000), vol. 415, pp. 261 284. Printed in the United Kingdom c 2000 Cambridge University Press 261 A scale-dependent dynamic model for large-eddy simulation: application to a neutral atmospheric

More information

Eco517 Fall 2013 C. Sims MCMC. October 8, 2013

Eco517 Fall 2013 C. Sims MCMC. October 8, 2013 Eco517 Fall 2013 C. Sims MCMC October 8, 2013 c 2013 by Christopher A. Sims. This document may be reproduced for educational and research purposes, so long as the copies contain this notice and are retained

More information

On the feasibility of merging LES with RANS for the near-wall region of attached turbulent flows

On the feasibility of merging LES with RANS for the near-wall region of attached turbulent flows Center for Turbulence Research Annual Research Briefs 1998 267 On the feasibility of merging LES with RANS for the near-wall region of attached turbulent flows By Jeffrey S. Baggett 1. Motivation and objectives

More information

Computational Fluid Dynamics 2

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

More information

A scale-dependent Lagrangian dynamic model for large eddy simulation of complex turbulent flows

A scale-dependent Lagrangian dynamic model for large eddy simulation of complex turbulent flows PHYSICS OF FLUIDS 17, 05105 005 A scale-dependent Lagrangian dynamic model for large eddy simulation of complex turbulent flows Elie Bou-Zeid a Department of Geography and Environmental Engineering and

More information

Practical Bayesian Optimization of Machine Learning. Learning Algorithms

Practical Bayesian Optimization of Machine Learning. Learning Algorithms Practical Bayesian Optimization of Machine Learning Algorithms CS 294 University of California, Berkeley Tuesday, April 20, 2016 Motivation Machine Learning Algorithms (MLA s) have hyperparameters that

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

Estimation of Turbulent Dissipation Rate Using 2D Data in Channel Flows

Estimation of Turbulent Dissipation Rate Using 2D Data in Channel Flows Proceedings of the 3 rd World Congress on Mechanical, Chemical, and Material Engineering (MCM'17) Rome, Italy June 8 10, 2017 Paper No. HTFF 140 ISSN: 2369-8136 DOI: 10.11159/htff17.140 Estimation of Turbulent

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

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

STA 4273H: Statistical Machine Learning

STA 4273H: Statistical Machine Learning STA 4273H: Statistical Machine Learning Russ Salakhutdinov Department of Computer Science! Department of Statistical Sciences! rsalakhu@cs.toronto.edu! h0p://www.cs.utoronto.ca/~rsalakhu/ Lecture 7 Approximate

More information

NONLINEAR FEATURES IN EXPLICIT ALGEBRAIC MODELS FOR TURBULENT FLOWS WITH ACTIVE SCALARS

NONLINEAR FEATURES IN EXPLICIT ALGEBRAIC MODELS FOR TURBULENT FLOWS WITH ACTIVE SCALARS June - July, 5 Melbourne, Australia 9 7B- NONLINEAR FEATURES IN EXPLICIT ALGEBRAIC MODELS FOR TURBULENT FLOWS WITH ACTIVE SCALARS Werner M.J. Lazeroms () Linné FLOW Centre, Department of Mechanics SE-44

More information

Sequential Monte Carlo Samplers for Applications in High Dimensions

Sequential Monte Carlo Samplers for Applications in High Dimensions Sequential Monte Carlo Samplers for Applications in High Dimensions Alexandros Beskos National University of Singapore KAUST, 26th February 2014 Joint work with: Dan Crisan, Ajay Jasra, Nik Kantas, Alex

More information

Dynamic k-equation Model for Large Eddy Simulation of Compressible Flows. Xiaochuan Chai and Krishnan Mahesh

Dynamic k-equation Model for Large Eddy Simulation of Compressible Flows. Xiaochuan Chai and Krishnan Mahesh 40th Fluid Dynamics Conference and Exhibit 8 June - July 00, Chicago, Illinois AIAA 00-506 Dynamic k-equation Model for Large Eddy Simulation of Compressible Flows Xiaochuan Chai and Krishnan Mahesh University

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

Proceedings of the 2012 Winter Simulation Conference C. Laroque, J. Himmelspach, R. Pasupathy, O. Rose, and A. M. Uhrmacher, eds.

Proceedings of the 2012 Winter Simulation Conference C. Laroque, J. Himmelspach, R. Pasupathy, O. Rose, and A. M. Uhrmacher, eds. Proceedings of the 2012 Winter Simulation Conference C. Laroque, J. Himmelspach, R. Pasupathy, O. Rose, and A. M. Uhrmacher, eds. OPTIMAL PARALLELIZATION OF A SEQUENTIAL APPROXIMATE BAYESIAN COMPUTATION

More information

Variational Methods in Bayesian Deconvolution

Variational Methods in Bayesian Deconvolution PHYSTAT, SLAC, Stanford, California, September 8-, Variational Methods in Bayesian Deconvolution K. Zarb Adami Cavendish Laboratory, University of Cambridge, UK This paper gives an introduction to the

More information

Markov Chain Monte Carlo methods

Markov Chain Monte Carlo methods Markov Chain Monte Carlo methods By Oleg Makhnin 1 Introduction a b c M = d e f g h i 0 f(x)dx 1.1 Motivation 1.1.1 Just here Supresses numbering 1.1.2 After this 1.2 Literature 2 Method 2.1 New math As

More information

Default Priors and Effcient Posterior Computation in Bayesian

Default Priors and Effcient Posterior Computation in Bayesian Default Priors and Effcient Posterior Computation in Bayesian Factor Analysis January 16, 2010 Presented by Eric Wang, Duke University Background and Motivation A Brief Review of Parameter Expansion Literature

More information

New Insights into History Matching via Sequential Monte Carlo

New Insights into History Matching via Sequential Monte Carlo New Insights into History Matching via Sequential Monte Carlo Associate Professor Chris Drovandi School of Mathematical Sciences ARC Centre of Excellence for Mathematical and Statistical Frontiers (ACEMS)

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

Hybrid LES RANS Method Based on an Explicit Algebraic Reynolds Stress Model

Hybrid LES RANS Method Based on an Explicit Algebraic Reynolds Stress Model Hybrid RANS Method Based on an Explicit Algebraic Reynolds Stress Model Benoit Jaffrézic, Michael Breuer and Antonio Delgado Institute of Fluid Mechanics, LSTM University of Nürnberg bjaffrez/breuer@lstm.uni-erlangen.de

More information

Explicit algebraic Reynolds stress models for boundary layer flows

Explicit algebraic Reynolds stress models for boundary layer flows 1. Explicit algebraic models Two explicit algebraic models are here compared in order to assess their predictive capabilities in the simulation of boundary layer flow cases. The studied models are both

More information

J.-L. Guermond 1 FOR TURBULENT FLOWS LARGE EDDY SIMULATION MODEL A HYPERVISCOSITY SPECTRAL

J.-L. Guermond 1 FOR TURBULENT FLOWS LARGE EDDY SIMULATION MODEL A HYPERVISCOSITY SPECTRAL A HYPERVISCOSITY SPECTRAL LARGE EDDY SIMULATION MODEL FOR TURBULENT FLOWS J.-L. Guermond 1 Collaborator: S. Prudhomme 2 Mathematical Aspects of Computational Fluid Dynamics Oberwolfach November 9th to

More information

arxiv: v1 [stat.me] 30 Sep 2009

arxiv: v1 [stat.me] 30 Sep 2009 Model choice versus model criticism arxiv:0909.5673v1 [stat.me] 30 Sep 2009 Christian P. Robert 1,2, Kerrie Mengersen 3, and Carla Chen 3 1 Université Paris Dauphine, 2 CREST-INSEE, Paris, France, and

More information

On Markov chain Monte Carlo methods for tall data

On Markov chain Monte Carlo methods for tall data On Markov chain Monte Carlo methods for tall data Remi Bardenet, Arnaud Doucet, Chris Holmes Paper review by: David Carlson October 29, 2016 Introduction Many data sets in machine learning and computational

More information

SAMSI Astrostatistics Tutorial. More Markov chain Monte Carlo & Demo of Mathematica software

SAMSI Astrostatistics Tutorial. More Markov chain Monte Carlo & Demo of Mathematica software SAMSI Astrostatistics Tutorial More Markov chain Monte Carlo & Demo of Mathematica software Phil Gregory University of British Columbia 26 Bayesian Logical Data Analysis for the Physical Sciences Contents:

More information

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling Turbulence Modeling Niels N. Sørensen Professor MSO, Ph.D. Department of Civil Engineering, Alborg University & Wind Energy Department, Risø National Laboratory Technical University of Denmark 1 Outline

More information

One Pseudo-Sample is Enough in Approximate Bayesian Computation MCMC

One Pseudo-Sample is Enough in Approximate Bayesian Computation MCMC Biometrika (?), 99, 1, pp. 1 10 Printed in Great Britain Submitted to Biometrika One Pseudo-Sample is Enough in Approximate Bayesian Computation MCMC BY LUKE BORNN, NATESH PILLAI Department of Statistics,

More information

A priori testing of subgrid-scale. models for the velocity-pressure. and vorticity-velocity formulations

A priori testing of subgrid-scale. models for the velocity-pressure. and vorticity-velocity formulations Center for Turbulence Research Proceedings of the Summer Program 1996 309 A priori testing of subgrid-scale models for the velocity-pressure and vorticity-velocity formulations By G. S. Winckelmans 1,

More information

Web Appendix for Hierarchical Adaptive Regression Kernels for Regression with Functional Predictors by D. B. Woodard, C. Crainiceanu, and D.

Web Appendix for Hierarchical Adaptive Regression Kernels for Regression with Functional Predictors by D. B. Woodard, C. Crainiceanu, and D. Web Appendix for Hierarchical Adaptive Regression Kernels for Regression with Functional Predictors by D. B. Woodard, C. Crainiceanu, and D. Ruppert A. EMPIRICAL ESTIMATE OF THE KERNEL MIXTURE Here we

More information

Turbulent Vortex Dynamics

Turbulent Vortex Dynamics IV (A) Turbulent Vortex Dynamics Energy Cascade and Vortex Dynamics See T & L, Section 2.3, 8.2 We shall investigate more thoroughly the dynamical mechanism of forward energy cascade to small-scales, i.e.

More information

Lecture 6: Markov Chain Monte Carlo

Lecture 6: Markov Chain Monte Carlo Lecture 6: Markov Chain Monte Carlo D. Jason Koskinen koskinen@nbi.ku.dk Photo by Howard Jackman University of Copenhagen Advanced Methods in Applied Statistics Feb - Apr 2016 Niels Bohr Institute 2 Outline

More information

On Bayesian Computation

On Bayesian Computation On Bayesian Computation Michael I. Jordan with Elaine Angelino, Maxim Rabinovich, Martin Wainwright and Yun Yang Previous Work: Information Constraints on Inference Minimize the minimax risk under constraints

More information

A G-equation formulation for large-eddy simulation of premixed turbulent combustion

A G-equation formulation for large-eddy simulation of premixed turbulent combustion Center for Turbulence Research Annual Research Briefs 2002 3 A G-equation formulation for large-eddy simulation of premixed turbulent combustion By H. Pitsch 1. Motivation and objectives Premixed turbulent

More information

Approximate Bayesian Computation

Approximate Bayesian Computation Approximate Bayesian Computation Sarah Filippi Department of Statistics University of Oxford 09/02/2016 Parameter inference in a signalling pathway A RAS Receptor Growth factor Cell membrane Phosphorylation

More information

Variational Principal Components

Variational Principal Components Variational Principal Components Christopher M. Bishop Microsoft Research 7 J. J. Thomson Avenue, Cambridge, CB3 0FB, U.K. cmbishop@microsoft.com http://research.microsoft.com/ cmbishop In Proceedings

More information

Choosing the Summary Statistics and the Acceptance Rate in Approximate Bayesian Computation

Choosing the Summary Statistics and the Acceptance Rate in Approximate Bayesian Computation Choosing the Summary Statistics and the Acceptance Rate in Approximate Bayesian Computation COMPSTAT 2010 Revised version; August 13, 2010 Michael G.B. Blum 1 Laboratoire TIMC-IMAG, CNRS, UJF Grenoble

More information

Computational statistics

Computational statistics Computational statistics Markov Chain Monte Carlo methods Thierry Denœux March 2017 Thierry Denœux Computational statistics March 2017 1 / 71 Contents of this chapter When a target density f can be evaluated

More information

Computer Vision Group Prof. Daniel Cremers. 11. Sampling Methods

Computer Vision Group Prof. Daniel Cremers. 11. Sampling Methods Prof. Daniel Cremers 11. Sampling Methods Sampling Methods Sampling Methods are widely used in Computer Science as an approximation of a deterministic algorithm to represent uncertainty without a parametric

More information

STRESS TRANSPORT MODELLING 2

STRESS TRANSPORT MODELLING 2 STRESS TRANSPORT MODELLING 2 T.J. Craft Department of Mechanical, Aerospace & Manufacturing Engineering UMIST, Manchester, UK STRESS TRANSPORT MODELLING 2 p.1 Introduction In the previous lecture we introduced

More information

Self Adaptive Particle Filter

Self Adaptive Particle Filter Self Adaptive Particle Filter Alvaro Soto Pontificia Universidad Catolica de Chile Department of Computer Science Vicuna Mackenna 4860 (143), Santiago 22, Chile asoto@ing.puc.cl Abstract The particle filter

More information