Coupled Lattice Boltzmann and Molecular Dynamics simulations on massively parallel computers

Size: px
Start display at page:

Download "Coupled Lattice Boltzmann and Molecular Dynamics simulations on massively parallel computers"

Transcription

1 Coupled Lattice Boltzmann and Molecular Dynamics simulations on massively parallel computers Jens Harting 1,2, Stefan Frijters 1, Florian Janoschek 1,2, and Florian Günther 1 1 Department of Applied Physics, Eindhoven University of Technology, Den Dolech 2, 5600MB Eindhoven, The Netherlands {f.a.r.janoschek, s.c.j.frijters, f.s.guenther}@tue.nl 2 Institute for Computational Physics, University of Stuttgart, Pfaffenwaldring 27, Stuttgart, Germany jens@icp.uni-stuttgart.de Complex colloidal fluids play an important role in many branches of industry. Examples include particle-stabilized emulsions in cosmetics, food and oil industries. Their understanding requires a study which resolves their microscopic structure, while still attaining sufficiently large length scales. The lattice Boltzmann method, owing to its high degree of locality, allows for such studies, when parallelized on modern supercomputers. However, exploiting these possibilities on hundreds of thousands of cores is a non-trivial task. We report on our experiences when employing large fractions of the IBM Blue Gene/P system at the Jülich Supercomputing Centre for our simulations and summarize recent results on particle-stabilized emulsions. 1 Introduction Stabilizing emulsions by employing colloidal particles is a very attractive tool in the food, cosmetics and medical industries. The underlying microscopic processes of this stabilization can be explained by assuming an oil-water mixture. Without any additives, these liquids will phase separate, but the mixture can be stabilized by adding small particles. If these particles diffuse to the interface they will adsorb there, reducing interfacial free energy and stabilizing the mixture. The particles in these mixtures block Ostwald ripening, which is one of the main processes leading to drop coarsening in emulsions. Thus, blocking this process allows for long-term stabilization of these emulsions. The stabilized drops can be used to produce new materials with complex hierarchical structure. Interestingly, many of the properties of such systems can not be explained with theories derived for surfactantstabilized systems. This is due to the larger size of the particles compared to the surfactant molecules, and their lack of amphiphilic properties. New theoretical models have been developed (and have been underlined experimentally), incorporating specific features of particle-stabilized systems that have no direct analogue in surfactant systems. Quantitatively, however, the description of these systems still leaves to be desired. A promising method to understand the dynamic properties of particle-stabilized multiphase flows can be found in computer simulations. However, a suitable simulation algorithm must be able to deal not only with simple fluid dynamics, but it is also required to simulate several fluid species and particle-particle and particle-fluid interactions. Some recent approaches trying to solve these problems utilize the lattice Boltzmann (LB) method for the description of the solvents 1. The LB method can be seen as an alternative to conventional Navier-Stokes solvers and is well-established in the literature. A number of multiphase and multicomponent models that are comparably straightforward to implement exist, making it attractive 1

2 for our current application. In addition, boundary conditions have been developed to simulate suspended finite-size particles in flow. Microscopic studies such as these allow for a direct link to macroscopic experimental data and will lead to a sustantial improvement of our understanding of particle-laden multiphase flows. These simulations remain computationally very challenging because typical particles need to be at least 10 LB length units in diameter and typical droplet diameters should be larger by an order of magnitude. To reduce finite-size effects and to acquire a statistically relevant number of droplets, the side length of the volume of interest easily reaches LB length units touching the limit of what is currently possible on high-end supercomputers. Another constraint is given by the very small time step in the simulations. The hydrodynamic interactions between the particles need to be resolved on the same scale as the particle motion, pushing our time resolution down to the nanosecond scale. To still be able to reach steady states, typical simulation runs require millions of LB time steps. This means that 0.5 to 1 rack months on the Blue Gene/P system JUGENE in Jülich might be required for a single simulation. 2 Simulation method and implementation We use the lattice Boltzmann (LB) method as the basis for our simulations 1. In our simulations, we effect the fluid-fluid interactions through the Shan-Chen multicomponent model 2, 3, while we use a variant of Ladd s method to couple the particles to our fluid 4, 5. Particle-particle interactions and particle dynamics are modeled by a molecular dynamics algorithm. The code has recently been expanded to allow for spherical particles as well as ellipsoidal ones. For a more detailed description of our simulation methods the reader is referred to 6, 7. The development of our simulation code LB3D started already in 1999 as a parallel LB solver. As the scientific focus at that time was on the behaviour of complex fluid mixtures under shear, the ability to model up to three fluid species, one of them with amphiphilic properties, using Shan and Chen s aforementioned approach was one the first features implemented. Already in 2004, LB3D was awarded a gold star rating by the Edinburgh Parallel Computing Centre for scaling almost linearly to 1024 processors and it also won several further prizes as part of the TeraGyroid project 8. Further applications of the code encompass flow in porous media 9 and fluid interactions with rough and hydrophobic surfaces In the meantime, the application was ported to most supercomputing platforms available. A parallel molecular dynamics (MD) code was integrated into LB3D in After considerable changes and extensions both parts of the code now use the same 3-dimensional spatial decomposition scheme, the Message Passing Interface (MPI) for communication, and modern Fortran 95 language elements. The simultaneous availability of Lagrangian particles in the same code as the Eulerian LB fluid opened up new applications for LB3D, such as tracking the velocity field in micromixers using massless tracer particles 14, a coarse-grained model for red blood cells 15, or colloidal particles with variable wettability as described in this report 6. Due to the strong locality of the LB equation and because the relevant interactions in colloidal systems are short-range, an efficient parallelization of such systems can be expected. In the past, LB3D indeed showed very good scalability. On a machine such as JUGENE, the IBM Blue Gene/P system at Jülich Supercomputing Centre (JSC), with cores, however, it is crucial to minimize communication costs and serial parts of a code even further in order to maintain high efficiency when running on large portions of the machine. Initially, LB3D showed only low effi- 2

3 speedup normalized to 1024 cores before after ideal number of cores [1024] speedup normalized to 1024 cores before after ideal number of cores [1024] (a) (b) Figure 1. Strong scaling of LB3D on the Blue Gene/P before and after our optimizations. (a) relates to a system with only one fluid component so the effect of matching or mismatching topologies of network and domain decomposition can be examined better. (b) refers to a system with two fluid species and suspended particles as they are of interest in this paper. The absolute execution times for small core counts did not change significantly (taken from Ref. 7 ). ciency there in strong scaling beyond cores. At the Jülich Blue Gene/P Extreme Scaling Workshop 2011 we could relate this to a mismatch of the network topology of the domain decomposition in the code and the network actually employed for point-to-point communication. The Blue Gene/P provides direct links only between direct neighbors in a three-dimensional torus, so a mismatch can cause severe performance losses. We investigated this issue for a system of lattice sites carrying only one fluid species and no particles. Limiting ourselves to this simpler system compared to the systems of interest later on has the benefit that the reduced ratio of computation to communication costs makes possible bottlenecks more visible. We find that if we allow MPI_Cart_create() to reorder process ranks and manually choose a domain decomposition based on the known hardware topology, efficiency can be brought close to ideal for this system. A comparison of the speedup before and after this optimization is shown in Fig. 1(a). Systems containing colloids and two fluid species were known to slowly degrade in parallel efficiency when the number of cores was increased. This is demonstrated in Fig. 1(b) for a benchmark system of lattice nodes and uniformly distributed particles with a radius of 5 lattice units (resulting in a volume concentration of about 20%). Since the degradation was not visible for a pure LB system (Fig. 1(a)), it initially was attributed to load imbalances and communication overhead related to the suspended particles. During the Scaling Workshop we identified a non-parallelized loop over all particles in one of the subroutines implementing the coupling of the colloidal particles and the two fluids as the actual reason. Due to the low computational cost per iteration compared to the overall coupling costs for colloids and fluids, at smaller numbers of particles or CPU cores this part of the code was not recognized as a possible bottleneck. A complete parallelization of the respective parts of the code produced a nearly ideal speedup up to cores also for this system. Both 3

4 speedup curves are depicted in Fig. 1(b). Actual production runs require checkpointing and the output of physical observables to disk, which is not accounted for in the benchmarks above. Pickering systems require output at most once per 100 to 1000 LB time steps, so the performance of the output routines is of inferior importance. Using parallel HDF5 output allows us to store fluid density fields of 4.6GB size for a system of lattice sites and particles within on average 29s when using the whole system ( cores). This corresponds to the time required to simulate 100 LB steps, so even at maximum core count possible and maximum I/O frequency not more than 50% of the time is spent on storing output. Particle configurations are typically smaller by two orders of magnitude than a density field. Therefore, this information is still written serially by the root process. Since strongly asymmetric point-to-point communication patterns are likely to produce buffer overflows and fail at high core counts, collective MPI operations are applied for data accumulation. However, the intuitive choice of MPI_Gatherv() is not optimal since on Blue Gene/P, the specially optimized implementation of MPI_Allgatherv() proved to be significantly faster at the cost of requiring one receive buffer per task. For MPI_Allgatherv() we measure an absolute time required to write one complete particle configuration of approximately 10s and a speedup of 77 on cores compared to MPI_Gatherv(). For even larger systems, however, MPI_Allgatherv() imposes a lower limit regarding the maximum number of particles, as receive buffers able to store the whole particle configuration need to be allocated four times per node (once per core) instead of only once on the node running the root process. Figure 2. Droplets subjected to shear but stabilized by particles deform and might even break for high shear rates. 3 Simulation results We apply our method to study the deformation of a liquid droplet under steady shear. Here, the simulation setup is a typical Couette flow where the upper and lower boundary 4

5 are moved by Lees-Edwards boundary conditions. A spherical droplet with radius R is initially placed at the centre of the system, which can be characterized by its capillary number Ca ηγ R σ. The surface tension σ can be related to the Shan-Chen parameter gcc0, η is the dynamic viscosity and γ is the shear rate. The deformation of the droplet is measured by fitting an ellipse to a two-dimensional projection of the droplet, where L and B are L B the length and breadth of the ellipse, respectively: D L+B. As shown by Taylor and reconfirmed in our simulations, for two fluids of equal density and equal viscosity one 16, 17. While there have been numerous analytical studies, obtains D = Ca for D 1 experiments and simulations on the deformation of simple liquid droplets within the last century, the case of particle covered droplets has not been covered in such detail and it is still not fully clear how the stability and deformability changes when particles have adsorbed to the liquid-liquid interface. In our simulations we can study these effects in detail by varying the droplet size, the number of particles, the particle size, their contact angle, as well as the shear rate and interfacial tension. Fig. 2 shows the deformation of a particle-covered droplet for various moderate capillary numbers. As can be observed from the plot, the deformation shows an almost parabolic behaviour and a non-uniform particle distribution can be observed at the interface (see inset figures). For even larger shear rates, the droplets break up. The capillary numbers have been computed based on the radius of the large original droplet and if one would rescale it with the radius of the small droplets occurring after breakup, the curves would be shifted towards smaller Ca. Figure 3. Snapshots of a 3D Bijel (a) and a Pickering emulsion (b): particles (green) self-assemble at the interface between two immiscible fluids (shaded in red and blue) and stabilize a bicontinuous interface (a) or droplets (b). We studied in detail how particles travel towards the fluid-fluid interface and get jammed there generating fluid-bicontinuous gels (so-called Bijels 18 ) as shown in Fig. 3a. Further, it was demonstrated that by modifying the lyophobic/lyophilic properties of the solved particles, the particles travel towards the fluid-fluid interface and accumulate at the surface of a droplet thus forming a Pickering emulsion (see Fig. 3b). Large scale parameter studies as well as investigations of the time dependent domain or droplet growth in Bijels and Pickering emulsions were performed. All simulations start from a random mixture of fluids and particles, modelling a temperature quench. At the beginning of the simulation, 5

6 (a) (b) Figure 4. Two snapshots of emulsions stabilized by particles are shown for an aspect ratio m = 2, a volume concentration of C 0.2 and a contact angle θ = 90. (a) Pickering emulsion for a fluid radio of 5 : 2. (b) Bijel for a fluid radio of 1 : 1 7. small scale droplets nucleate due to ballistic motion of particles and fluids. After the nucleation regime, the droplets grow due to spinodal decomposition. At some point the phase separation comes to a halt and droplets can only continue to grow due to coalescence (Ostwald ripening), which is limited due to the particles that were captured at the fluid-fluid interface. Ostwald ripening is one of the main processes leading to drop coarsening in emulsions and foams; hence stopping it allows long-term stabilization. Time-dependent measurements like these are very hard or even impossible to perform experimentally, but the processes involved determine the final properties of the emulsion. Therefore, we expect to be able to contribute to a better understanding of how the final product depends on fluid composition, fluid properties, particle concentration, particle size, or the contact angle the fluids form with the particle surface. We have studied in detail the phase behaviour of our system and determined a phase diagram demonstrating for which values of the particle concentration, fluid decomposition or contact angle either a Bijel or a Pickering emulsion is formed 6. It is our current main focus for these phases to understand the rheological properties of Bijels and Pickering emulsions in detail. For this, further large-scale sheared simulations will be performed in order to explore the complex non-newtonian properties of these systems. Collecting the data from a number of such large-scale runs will allow us to quantitatively compare the size distribution of the stabilized droplets as well as the rheological properties of such systems with experimental data. We also studied emulsions stabilized by non-spherical, anisotropic colloidal particles: ellipsoids with an aspect ratio of m = 2. Also for these ellipsoids, we observe two different phases: the Pickering emulsion (see Fig. 4(a)) and the Bijel (see Fig. 4(b)). Fig. 5 shows the transition from a Bijel to a Pickering emulsion for these ellipsoids with an aspect ratio of m = 2 and a particle volume concentration of C 0.2. The two control parameters used for the study of the phase transition are the fluid ratio and the contact angle θ. The squares denote the configurations which lead to a Bijel whereas the circles denote a resulting Pickering emulsion. If the amount of the two fluids present in the simulation is equal or not too 6

7 5:2 Fluid ratio 9:5 4:3 1: Contact angle θ[ ] Figure 5. Phase diagram demonstrating the transition from a Bijel to a Pickering emulsion. The contact angle θ and the density ratio between the two fluids are varied. The squares denote the configurations which lead to a Bijel whereas the circles denote a Pickering emulsion 7. different (e.g. a ratio of 4 : 3) we find a Bijel for all considered contact angles. However, if the fluid ratio is increased we find a Pickering emulsion. For intermediate fluid ratios the obtained phase depends on the chosen contact angle. For example for a ratio of 9 : 5 we get a Bijel for a contact angle of 90 and a Pickering emulsion for all higher values of θ. 4 Conclusion and outlook Suspensions of colloids in multiphase flows can exhibit many surprising effects, which are of potential interest to both fundamental science and industrial applications. Our investigation of the effect of colloids on the deformability of droplets has shown that when the fluid-fluid interface is almost saturated with colloids, the deformability of a droplet at a constant capillary number increases dramatically, and the breakup behaviour of those droplets at higher capillary number is also changed quantitatively. The results obtained for the particle-covered droplets will be compared to surfactant-covered droplets in similar systems, making a quantitative link between the two. On slightly larger scale, we investigated the behaviour of the particle-stabilized Pickering emulsions and Bijels, and found that the arrival at either phase after a temperature quench depends on many properties of the system, such as fluid ratio, and size and contact angle of the colloids. Our simulation code has been extended to include ellipsoidal colloids, which will introduce another parameter that can influence the formation of a particular phase. In the future, Janus particles will also be considered, having different wetting properties on different parts of the surface of the particle. Acknowledgments Besides support from JSC and IBM experts present at the Blue Gene/P Extreme Scaling workshop 2011 we acknowledge computing resources that were granted via GSC grants hss08 and hss10 and by PRACE (project pra036). 7

8 References 1. S. Succi, The Lattice Boltzmann Equation for Fluid Dynamics and Beyond, Numerical Mathematics and Scientific Computation. Oxford University Press, Oxford, X. Shan and H. Chen, Lattice Boltzmann model for simulating flows with multiple phases and components, Phys. Rev. E, 47, no. 3, , Mar H. Chen, B. M. Boghosian, P. V. Coveney, and M. Nekovee, A ternary lattice Boltzmann model for amphiphilic fluids, Proc. R. Soc. Lond. A, 456, 2043, C.K. Aidun, Y. Lu, and E.-J. Ding, Direct analysis of particulate suspensions with inertia using the discrete Boltzmann equation, J. Fluid Mech., 373, 287, A.J.C. Ladd and R. Verberg, Lattice-Boltzmann simulations of particle-fluid suspensions, J. Stat. Phys., 104, no. 5/6, , F. Jansen and J. Harting, From bijels to Pickering emulsions: A lattice Boltzmann study, Phys. Rev. E, 83, no. 4, , Apr F. Günther, F. Janoschek, S. Frijters, and J. Harting, Complex colloidal fluids: enabling a lattice Boltzmann solver for massively parallel simulations on the Blue Gene/P, submitted for publication, J. Chin, P. V. Coveney, and J. Harting, The TeraGyroid project collaborative steering and visualization in an HPC grid for modelling complex fluids, in: Proceedings of the UK e-science All Hands Meeting, A. Narváez, T. Zauner, F. Raischel, R. Hilfer, and J. Harting, Quantitative analysis of numerical estimates for the permeability of porous media from lattice-boltzmann simulations, J. Stat. Mech: Theor. Exp., 2010, P211026, J. Harting, C. Kunert, and H.J. Herrmann, Lattice Boltzmann simulations of apparent slip in hydrophobic microchannels, Europhys. Lett., 75, , C. Kunert and J. Harting, Roughness induced apparent boundary slip in microchannel flows, Phys. Rev. Lett., 99, , J. Hyväluoma and J. Harting, Slip flow over structured surfaces with entrapped microbubbles, Phys. Rev. Lett., 100, , C. Kunert, J. Harting, and O.I. Vinogradova, Random-roughness hydrodynamic boundary conditions, Phys. Rev. Lett., 105, , A. Sarkar, A. Narváez, and J. Harting, Quantification of the degree of mixing in chaotic micromixers using finite time lyapunov exponents, submitted for publication; arxiv: , F. Janoschek, F. Toschi, and J. Harting, Simplified particulate model for coarsegrained hemodynamics simulations, Phys. Rev. E, 82, , G.I. Taylor, The Viscosity of a Fluid Containing Small Drops of Another Fluid, Proc. R. Soc. Lond. A, 138, no. 834, 41 48, G.I. Taylor, The Formation of Emulsions in Definable Fields of Flow, Proc. R. Soc. Lond. A, 146, no. 858, , K. Stratford, R. Adhikari, I. Pagonabarraga, J.-C. Desplat, and M.E. Cates, Colloidal Jamming at Interfaces: A Route to Fluid-Bicontinuous Gels, Science, 309, no. 4, ,

Large Scale High Resolution Blood Flow Simulations

Large Scale High Resolution Blood Flow Simulations Large Scale High Resolution Blood Flow Simulations Florian Janoschek Jens Harting Federico Toschi Department of Applied Physics, Eindhoven University of Technology, The Netherlands Institute for Computational

More information

Multi Relaxation Time Lattice Boltzmann Simulations of Multiple Component Fluid Flows in Porous Media

Multi Relaxation Time Lattice Boltzmann Simulations of Multiple Component Fluid Flows in Porous Media Multi Relaxation Time Lattice Boltzmann Simulations of Multiple Component Fluid Flows in Porous Media Sebastian Schmieschek, Ariel Narváez, and Jens Harting Abstract The flow of fluid mixtures in complex

More information

arxiv: v2 [cond-mat.soft] 13 Sep 2014

arxiv: v2 [cond-mat.soft] 13 Sep 2014 Domain and droplet sizes in emulsions stabilized by colloidal particles arxiv:147.788v2 [cond-mat.soft] 13 Sep 214 Stefan Frijters, 1, Florian Günther, 1, 1, 2, and Jens Harting 1 Department of Applied

More information

arxiv: v2 [cond-mat.soft] 1 Apr 2014

arxiv: v2 [cond-mat.soft] 1 Apr 2014 Timescales of emulsion formation caused by anisotropic particles arxiv:131.6591v [cond-mat.soft] 1 Apr 014 Florian Günther, 1 Stefan Frijters, 1 1,, and Jens Harting 1 Department of Applied Physics, Eindhoven

More information

Massively parallel molecular-continuum simulations with the macro-micro-coupling tool Neumann, P.; Harting, J.D.R.

Massively parallel molecular-continuum simulations with the macro-micro-coupling tool Neumann, P.; Harting, J.D.R. Massively parallel molecular-continuum simulations with the macro-micro-coupling tool Neumann, P.; Harting, J.D.R. Published in: Hybrid particle-continuum methods in computational materials physics, 4-7

More information

Multiscale modeling of active fluids: selfpropellers and molecular motors. I. Pagonabarraga University of Barcelona

Multiscale modeling of active fluids: selfpropellers and molecular motors. I. Pagonabarraga University of Barcelona Multiscale modeling of active fluids: selfpropellers and molecular motors I. Pagonabarraga University of Barcelona Introduction Soft materials weak interactions Self-assembly Emergence large scale structures

More information

Lattice-Boltzmann simulation of colloid entrapment in amphiphilic mesophases: algorithm development and preliminary tests. HPC-Europa stay report

Lattice-Boltzmann simulation of colloid entrapment in amphiphilic mesophases: algorithm development and preliminary tests. HPC-Europa stay report Lattice-Boltzmann simulation of colloid entrapment in amphiphilic mesophases: algorithm development and preliminary tests. HPC-Europa stay report Dr. Nélido González-Segredo 1, 1 FOM Institute for Atomic

More information

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang,

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, yfwang09@stanford.edu 1. Problem setting In this project, we present a benchmark simulation for segmented flows, which contain

More information

Colloidal Particles at Liquid Interfaces: An Introduction

Colloidal Particles at Liquid Interfaces: An Introduction 1 Colloidal Particles at Liquid Interfaces: An Introduction Bernard P. Binks and Tommy S. Horozov Surfactant and Colloid Group, Department of Chemistry, University of Hull, Hull, HU6 7RX, UK 1.1 Some Basic

More information

Slip flow over structured surfaces with entrapped microbubbles Hyväluoma, J.; Harting, J.D.R.

Slip flow over structured surfaces with entrapped microbubbles Hyväluoma, J.; Harting, J.D.R. Slip flow over structured surfaces with entrapped microbubbles Hyväluoma, J.; Harting, J.D.R. Published in: Physical Review Letters DOI: 1.113/PhysRevLett.1.261 Published: 1/1/28 Document Version Publisher

More information

Interface Roughening in a Hydrodynamic Lattice- Gas Model with Surfactant

Interface Roughening in a Hydrodynamic Lattice- Gas Model with Surfactant Wesleyan University WesScholar Division III Faculty Publications Natural Sciences and Mathematics 1996 Interface Roughening in a Hydrodynamic Lattice- Gas Model with Surfactant Francis Starr Wesleyan University

More information

BIJEL CAPSULES. Institute for Condensed Matter and Complex Systems and The Edinburgh Complex Fluid Partnership

BIJEL CAPSULES. Institute for Condensed Matter and Complex Systems and The Edinburgh Complex Fluid Partnership BIJEL CAPSULES J.W. Tavacoli, E.M. Herzig, and P.S Clegg Institute for Condensed Matter and Complex Systems and The Edinburgh Complex Fluid Partnership School of Physics, University of Edinburgh Bijel

More information

An introduction to the lattice Boltzmann method for multiphase flows with interfacially active components. Roar Skartlien 2012

An introduction to the lattice Boltzmann method for multiphase flows with interfacially active components. Roar Skartlien 2012 An introduction to the lattice Boltzmann method for multiphase flows with interfacially active components Roar Skartlien 2012 Multiphase flow a big research area gas/liquid/solids/particles combinations

More information

Simulation of Nematic-Isotropic Phase Coexistence in Liquid Crystals under Shear

Simulation of Nematic-Isotropic Phase Coexistence in Liquid Crystals under Shear Simulation of Nematic-Isotropic Phase Coexistence in Liquid Crystals under Shear Guido Germano 1,2 and Friederike Schmid 2 1 Physical Chemistry Philipps-University 3532 Marburg, Germany E-mail: germano@staff.uni-marburg.de

More information

arxiv:comp-gas/ v1 28 Apr 1993

arxiv:comp-gas/ v1 28 Apr 1993 Lattice Boltzmann Thermohydrodynamics arxiv:comp-gas/9304006v1 28 Apr 1993 F. J. Alexander, S. Chen and J. D. Sterling Center for Nonlinear Studies and Theoretical Division Los Alamos National Laboratory

More information

Single Curved Fiber Sedimentation Under Gravity. Xiaoying Rong, Dewei Qi Western Michigan University

Single Curved Fiber Sedimentation Under Gravity. Xiaoying Rong, Dewei Qi Western Michigan University Single Curved Fiber Sedimentation Under Gravity Xiaoying Rong, Dewei Qi Western Michigan University JunYong Zhu, Tim Scott USDA Forest Products Laboratory ABSTRACT Dynamics of single curved fiber sedimentation

More information

A Framework for Hybrid Parallel Flow Simulations with a Trillion Cells in Complex Geometries

A Framework for Hybrid Parallel Flow Simulations with a Trillion Cells in Complex Geometries A Framework for Hybrid Parallel Flow Simulations with a Trillion Cells in Complex Geometries SC13, November 21 st 2013 Christian Godenschwager, Florian Schornbaum, Martin Bauer, Harald Köstler, Ulrich

More information

Long-time behavior and different shear regimes in quenched binary mixtures

Long-time behavior and different shear regimes in quenched binary mixtures PHYSICAL REVIEW E 75, 011501 2007 Long-time behavior and different shear regimes in quenched binary mixtures G. Gonnella* Dipartimento di Fisica, Università di Bari, and INFN, Sezione di Bari, Via Amendola

More information

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters H. Köstler 2nd International Symposium Computer Simulations on GPU Freudenstadt, 29.05.2013 1 Contents Motivation walberla software concepts

More information

Aging in laponite water suspensions. P. K. Bhattacharyya Institute for Soldier Nanotechnologies Massachusetts Institute of Technology

Aging in laponite water suspensions. P. K. Bhattacharyya Institute for Soldier Nanotechnologies Massachusetts Institute of Technology Aging in laponite water suspensions. P. K. Bhattacharyya Institute for Soldier Nanotechnologies Massachusetts Institute of Technology Outline Laponite Basic background. Laponite in suspension Bonn et al.,

More information

Edinburgh Research Explorer

Edinburgh Research Explorer Edinburgh Research Explorer Detachment energies of spheroidal particles from fluid-fluid interfaces Citation for published version: Davies, GB, Krueger, T, Coveney, PV & Harting, J 2014, 'Detachment energies

More information

Lecture 5: Macromolecules, polymers and DNA

Lecture 5: Macromolecules, polymers and DNA 1, polymers and DNA Introduction In this lecture, we focus on a subfield of soft matter: macromolecules and more particularly on polymers. As for the previous chapter about surfactants and electro kinetics,

More information

COMPARISON OF CPU AND GPU IMPLEMENTATIONS OF THE LATTICE BOLTZMANN METHOD

COMPARISON OF CPU AND GPU IMPLEMENTATIONS OF THE LATTICE BOLTZMANN METHOD XVIII International Conference on Water Resources CMWR 2010 J. Carrera (Ed) c CIMNE, Barcelona, 2010 COMPARISON OF CPU AND GPU IMPLEMENTATIONS OF THE LATTICE BOLTZMANN METHOD James.E. McClure, Jan F. Prins

More information

Single curved fiber sedimentation under gravity

Single curved fiber sedimentation under gravity Single curved fiber sedimentation under gravity Xiaoying Rong, Dewei Qi, Guowei He, JunYong Zhu, Tim Scott Abstract Dynamics of single curved fiber sedimentation under gravity are simulated by using the

More information

Coarse-graining limits in open and wall-bounded dissipative particle dynamics systems

Coarse-graining limits in open and wall-bounded dissipative particle dynamics systems THE JOURNAL OF CHEMICAL PHYSICS 124, 184101 2006 Coarse-graining limits in open and wall-bounded dissipative particle dynamics systems Igor V. Pivkin and George E. Karniadakis a Division of Applied Mathematics,

More information

Lateral Migration and Orientation of Elliptical Particles in Poiseuille Flows

Lateral Migration and Orientation of Elliptical Particles in Poiseuille Flows Journal of Statistical Physics, Vol. 17, Nos. 1/2, April 22 ( 22) Lateral Migration and Orientation of Elliptical Particles in Poiseuille Flows Dewei Qi, 1 Lishi Luo, 2 Raja Aravamuthan, 3 and William

More information

DRAINAGE AND IMBIBITION CAPILLARY PRESSURE CURVES OF CARBONATE RESERVOIR ROCKS BY DIGITAL ROCK PHYSICS

DRAINAGE AND IMBIBITION CAPILLARY PRESSURE CURVES OF CARBONATE RESERVOIR ROCKS BY DIGITAL ROCK PHYSICS SCA2012-56 1/6 DRAINAGE AND IMBIBITION CAPILLARY PRESSURE CURVES OF CARBONATE RESERVOIR ROCKS BY DIGITAL ROCK PHYSICS Y. Mu 1, Q. Fang 1, C. Baldwin 1, J. Töelke 1, A. Grader 1, M. Dernaika 2, and Z. Kalam

More information

arxiv: v2 [cond-mat.soft] 3 Apr 2012

arxiv: v2 [cond-mat.soft] 3 Apr 2012 Effects of nanoparticles and surfactant on droplets in shear flow Stefan Frijters, 1, Florian Günther, 1, and Jens Harting 1,2, 1 Department of Applied Physics, Eindhoven University of Technology, Den

More information

Dissipative Particle Dynamics: Foundation, Evolution and Applications

Dissipative Particle Dynamics: Foundation, Evolution and Applications Dissipative Particle Dynamics: Foundation, Evolution and Applications Lecture 4: DPD in soft matter and polymeric applications George Em Karniadakis Division of Applied Mathematics, Brown University &

More information

Large-scale lattice-boltzmann simulations over lambda networks

Large-scale lattice-boltzmann simulations over lambda networks Large-scale lattice-boltzmann simulations over lambda networks Centre for Computational Science, Department of Chemistry, University College London 20 Gordon Street, London WC1H 0AJ, United Kingdom E-mail:

More information

ab initio Electronic Structure Calculations

ab initio Electronic Structure Calculations ab initio Electronic Structure Calculations New scalability frontiers using the BG/L Supercomputer C. Bekas, A. Curioni and W. Andreoni IBM, Zurich Research Laboratory Rueschlikon 8803, Switzerland ab

More information

*blood and bones contain colloids. *milk is a good example of a colloidal dispersion.

*blood and bones contain colloids. *milk is a good example of a colloidal dispersion. Chap. 3. Colloids 3.1. Introduction - Simple definition of a colloid: a macroscopically heterogeneous system where one component has dimensions in between molecules and macroscopic particles like sand

More information

Scalable, performant, and resilient large-scale applications of molecular process engineering

Scalable, performant, and resilient large-scale applications of molecular process engineering Scalable, performant, and resilient large-scale applications of molecular process engineering M. Horsch,1 P. Gralka,2 C. Niethammer,3 N. Tchipev,4 J. Vrabec,5 H. Hasse1 1 University of Kaiserslautern,

More information

An electrokinetic LB based model for ion transport and macromolecular electrophoresis

An electrokinetic LB based model for ion transport and macromolecular electrophoresis An electrokinetic LB based model for ion transport and macromolecular electrophoresis Raffael Pecoroni Supervisor: Michael Kuron July 8, 2016 1 Introduction & Motivation So far an mesoscopic coarse-grained

More information

Numerical Simulation of Viscous Fingering Phenomenon in Immiscible Displacement of Two Fluids in Porous Media Using Lattice Boltzmann Method

Numerical Simulation of Viscous Fingering Phenomenon in Immiscible Displacement of Two Fluids in Porous Media Using Lattice Boltzmann Method nd Micro and Nano Flows Conference West London, UK, 1- September 009 Numerical Simulation of Viscous Fingering Phenomenon in Immiscible Displacement of Two Fluids in Porous Media Using Lattice Boltzmann

More information

NEAR-WALL TURBULENCE-BUBBLES INTERACTIONS IN A CHANNEL FLOW AT Re =400: A DNS/LES INVESTIGATION

NEAR-WALL TURBULENCE-BUBBLES INTERACTIONS IN A CHANNEL FLOW AT Re =400: A DNS/LES INVESTIGATION ABSTRACT NEAR-WALL TURBULENCE-BUBBLES INTERACTIONS IN A CHANNEL FLOW AT Re =400: A DNS/LES INVESTIGATION D. Métrailler, S. Reboux and D. Lakehal ASCOMP GmbH Zurich, Technoparkstr. 1, Switzerland Metrailler@ascomp.ch;

More information

A phenomenological model for shear-thickening in wormlike micelle solutions

A phenomenological model for shear-thickening in wormlike micelle solutions EUROPHYSICS LETTERS 5 December 999 Europhys. Lett., 8 (6), pp. 76-7 (999) A phenomenological model for shear-thickening in wormlike micelle solutions J. L. Goveas ( ) and D. J. Pine Department of Chemical

More information

Soft Matter. Volume 12 Number August 2016 Pages

Soft Matter. Volume 12 Number August 2016 Pages Volume 12 Number 31 21 August 2016 Pages 6499 6676 www.softmatter.org ISSN 1744-683X PAPER Jens Harting et al. Controlled capillary assembly of magnetic Janus particles at fluid fluid interfaces PAPER

More information

Proposed approximation for contact angles in Shan-and-Chen-type multicomponent multiphase lattice Boltzmann models

Proposed approximation for contact angles in Shan-and-Chen-type multicomponent multiphase lattice Boltzmann models PHYSICAL REVIEW E 7, 0701 007 Proposed approximation for contact angles in Shan-and-Chen-type multicomponent multiphase lattice Boltzmann models Haibo Huang, 1 Daniel T. Thorne, Jr., Marcel G. Schaap,

More information

Parallel spacetime approach to turbulence: computation of unstable periodic orbits and the dynamical zeta function

Parallel spacetime approach to turbulence: computation of unstable periodic orbits and the dynamical zeta function Parallel spacetime approach to turbulence: computation of unstable periodic orbits and the dynamical zeta function Peter V. Coveney 1, Bruce M. Boghosian 2, Luis Fazendeiro 1, Derek Groen 1 Lorentz Center

More information

Multiscale simulations of sliding droplets

Multiscale simulations of sliding droplets Acta Mech https://doi.org/10.1007/s00707-018-2264-6 ORIGINAL PAPER J. J. Derksen A. E. Komrakova Multiscale simulations of sliding droplets Received: 15 February 2018 / Revised: 15 June 2018 The Author(s)

More information

Adsorption Dynamics in Pickering Emulsions

Adsorption Dynamics in Pickering Emulsions Progress of Theoretical Physics Supplement No. 175, 2008 81 Adsorption Dynamics in Pickering Emulsions Yuichi Hirose, Shigeyuki Komura and Tadashi Kato Department of Chemistry, Graduate School of Science

More information

Chapter 7. Pickering Stabilisation ABSTRACT

Chapter 7. Pickering Stabilisation ABSTRACT Chapter 7 Pickering Stabilisation ABSTRACT In this chapter we investigate the interfacial properties of Pickering emulsions. Based upon findings that indicate these emulsions to be thermodynamically stable,

More information

Parallel spacetime approach to turbulence

Parallel spacetime approach to turbulence Parallel spacetime approach to turbulence Peter V. Coveney1, Bruce M. Boghosian2, 1 1 Luis Fazendeiro, Derek Groen DEISA PRACE Symposium 2011, April 13-14 2011, Helsinki, Finland p.v.coveney@ucl.ac.uk

More information

Numerical modelling of phase change processes in clouds. Challenges and Approaches. Martin Reitzle Bernard Weigand

Numerical modelling of phase change processes in clouds. Challenges and Approaches. Martin Reitzle Bernard Weigand Institute of Aerospace Thermodynamics Numerical modelling of phase change processes in clouds Challenges and Approaches Martin Reitzle Bernard Weigand Introduction Institute of Aerospace Thermodynamics

More information

arxiv: v1 [cond-mat.soft] 25 Jun 2014

arxiv: v1 [cond-mat.soft] 25 Jun 2014 EPJ manuscript No. (will be inserted by the editor) Recent advances in the simulation of particle-laden flows Jens Harting 1,2,a, Stefan Frijters 1, Marco Ramaioli 3, Martin Robinson 4, Dietrich E. Wolf

More information

Network formation in viscoelastic phase separation

Network formation in viscoelastic phase separation INSTITUTE OF PHYSICSPUBLISHING JOURNAL OFPHYSICS: CONDENSED MATTER J. Phys.: Condens. Matter 15 (2003) S387 S393 PII: S0953-8984(03)54761-0 Network formation in viscoelastic phase separation Hajime Tanaka,

More information

Lattice-Boltzmann vs. Navier-Stokes simulation of particulate flows

Lattice-Boltzmann vs. Navier-Stokes simulation of particulate flows Lattice-Boltzmann vs. Navier-Stokes simulation of particulate flows Amir Eshghinejadfard, Abouelmagd Abdelsamie, Dominique Thévenin University of Magdeburg, Germany 14th Workshop on Two-Phase Flow Predictions

More information

Direct Numerical Simulations of Gas-Liquid Flows

Direct Numerical Simulations of Gas-Liquid Flows Direct Numerical Simulations of Gas-Liquid Flows 1 Gretar Tryggvason*; 1 Jiacai Lu; 2 Ming Ma 1 Johns Hopkins University, Baltimore, MD, USA; 2 University of Notre Dame, Notre Dame, IN, USA Introduction

More information

Viscosity of magmas containing highly deformable bubbles

Viscosity of magmas containing highly deformable bubbles Journal of Volcanology and Geothermal Research 105 (2001) 19±24 www.elsevier.nl/locate/jvolgeores Viscosity of magmas containing highly deformable bubbles M. Manga a, *, M. Loewenberg b a Department of

More information

Measuring microbubble clustering in turbulent flow

Measuring microbubble clustering in turbulent flow Slide 1 Measuring microbubble clustering in turbulent flow Enrico Calzavarini University of Twente The Netherlands In collaboration with T. H van den Berg, S. Luther, F. Toschi, D. Lohse Slide 2 Motivation

More information

Particle-stabilized foams

Particle-stabilized foams Particle-stabilized foams Brent S. Murray, Bernie P. Binks*, Eric Dickinson, Zhiping Du, Rammile Ettelaie & Thomas Kostakis Food Colloids Group Procter Department of Food Science, University of Leeds,

More information

On Portability, Performance and Scalability of a MPI OpenCL Lattice Boltzmann Code

On Portability, Performance and Scalability of a MPI OpenCL Lattice Boltzmann Code On Portability, Performance and Scalability of a MPI OpenCL Lattice Boltzmann Code E Calore, S F Schifano, R Tripiccione Enrico Calore INFN Ferrara, Italy 7 th Workshop on UnConventional High Performance

More information

Simulations of dispersed multiphase flow at the particle level

Simulations of dispersed multiphase flow at the particle level Simulations of dispersed multiphase flow at the particle level Jos Derksen Chemical Engineering Delft University of Technology Netherlands j.j.derksen@tudelft.nl http://homepage.tudelft.nl/s0j2f/ Multiphase

More information

Lecture 7: Rheology and milli microfluidic

Lecture 7: Rheology and milli microfluidic 1 and milli microfluidic Introduction In this chapter, we come back to the notion of viscosity, introduced in its simplest form in the chapter 2. We saw that the deformation of a Newtonian fluid under

More information

Contents. Preface XIII. 1 General Introduction 1 References 6

Contents. Preface XIII. 1 General Introduction 1 References 6 VII Contents Preface XIII 1 General Introduction 1 References 6 2 Interparticle Interactions and Their Combination 7 2.1 Hard-Sphere Interaction 7 2.2 Soft or Electrostatic Interaction 7 2.3 Steric Interaction

More information

A method to reduce load imbalances in simulations of phase change processes with FS3D

A method to reduce load imbalances in simulations of phase change processes with FS3D A method to reduce load imbalances in simulations of phase change processes with FS3D Johannes Müller Philipp Offenhäuser Martin Reitzle Workshop on Sustained Simulation Performance HLRS, Stuttgart, Germany

More information

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

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

More information

Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU

Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU Khramtsov D.P., Nekrasov D.A., Pokusaev B.G. Department of Thermodynamics, Thermal Engineering and Energy Saving Technologies,

More information

An Immersed Boundary Method for Computing Anisotropic Permeability of Structured Porous Media

An Immersed Boundary Method for Computing Anisotropic Permeability of Structured Porous Media An Immersed Boundary Method for Computing Anisotropic Permeability of Structured Porous Media D.J. Lopez Penha a, B.J. Geurts a, S. Stolz a,b, M. Nordlund b a Dept. of Applied Mathematics, University of

More information

EPSRC Centre for Doctoral Training in Industrially Focused Mathematical Modelling

EPSRC Centre for Doctoral Training in Industrially Focused Mathematical Modelling EPSRC Centre for Doctoral Training in Industrially Focused Mathematical Modelling Ternary Phase Diagrams for Surfactant/Oil/Brine Mixtures Clint Wong Contents 1. Introduction... 2 2. Predicting Phase Behaviours...

More information

In-depth analysis of viscoelastic properties thanks to Microrheology: non-contact rheology

In-depth analysis of viscoelastic properties thanks to Microrheology: non-contact rheology In-depth analysis of viscoelastic properties thanks to Microrheology: non-contact rheology Application All domains dealing with soft materials (emulsions, suspensions, gels, foams, polymers, etc ) Objective

More information

arxiv:cond-mat/ v1 [cond-mat.soft] 18 Sep 2000

arxiv:cond-mat/ v1 [cond-mat.soft] 18 Sep 2000 arxiv:cond-mat/0009259v1 [cond-mat.soft] 18 Sep 2000 Two remarks on wetting and emulsions P. G. de Gennes Collège de France, 11 place M. Berthelot, 75231 Paris Cedex, France June 12, 2018 Abstract This

More information

The Blue Gene/P at Jülich Case Study & Optimization. W.Frings, Forschungszentrum Jülich,

The Blue Gene/P at Jülich Case Study & Optimization. W.Frings, Forschungszentrum Jülich, The Blue Gene/P at Jülich Case Study & Optimization W.Frings, Forschungszentrum Jülich, 26.08.2008 Jugene Case-Studies: Overview Case Study: PEPC Case Study: racoon Case Study: QCD CPU0CPU3 CPU1CPU2 2

More information

arxiv: v3 [cond-mat.soft] 14 Nov 2016

arxiv: v3 [cond-mat.soft] 14 Nov 2016 Deformation and break-up of viscoelastic droplets in confined shear flow A.Gupta 1, M. Sbragaglia 1 1 Department of Physics and INFN, University of Tor Vergata, Via della Ricerca Scientifica 1, 00133 Rome,

More information

arxiv:cond-mat/ v1 [cond-mat.stat-mech] 11 Dec 2002

arxiv:cond-mat/ v1 [cond-mat.stat-mech] 11 Dec 2002 arxiv:cond-mat/0212257v1 [cond-mat.stat-mech] 11 Dec 2002 International Journal of Modern Physics B c World Scientific Publishing Company VISCOUS FINGERING IN MISCIBLE, IMMISCIBLE AND REACTIVE FLUIDS PATRICK

More information

7 The Navier-Stokes Equations

7 The Navier-Stokes Equations 18.354/12.27 Spring 214 7 The Navier-Stokes Equations In the previous section, we have seen how one can deduce the general structure of hydrodynamic equations from purely macroscopic considerations and

More information

Numerical Simulation of the Oil-water Distribution Law in X Block Geology by Using the STARS Mode

Numerical Simulation of the Oil-water Distribution Law in X Block Geology by Using the STARS Mode Research Journal of Applied Sciences, Engineering and Technology 5(8): 2648-2655, 2013 ISSN: 2040-7459; e-issn: 2040-7467 Maxwell Scientific Organization, 2013 Submitted: September 10, 2012 Accepted: October

More information

Complex Fluids. University of California - Santa Barbara, CA April 26, Abstract

Complex Fluids. University of California - Santa Barbara, CA April 26, Abstract Gravitational Effects on Structure Development in Quenched Complex Fluids V. E. Badalassi, a H. D. Ceniceros b and S. Banerjee c a,c Department of Chemical Engineering, b Department of Mathematics University

More information

(a). t = 0 (b). t = 0.276

(a). t = 0 (b). t = 0.276 10 (a). t = 0 (b). t = 0.276 Figure 8: Snapshots of the sedimentation of 5040 disks of diameter 10/192 cm in 2D (W =8 cm). The initial lattice is disordered. from t = 0:026 to t = 0:476. In Figure 6, a

More information

Simulation of Soot Filtration on the Nano-, Micro- and Meso-scale

Simulation of Soot Filtration on the Nano-, Micro- and Meso-scale Simulation of Soot Filtration on the Nano-, Micro- and Meso-scale L. Cheng 1, S. Rief 1, A. Wiegmann 1, J. Adler 2, L. Mammitzsch 2 and U. Petasch 2 1 Fraunhofer-Institut Techno- und Wirtschaftsmathematik,

More information

spreading of drops on soft surfaces

spreading of drops on soft surfaces Supplementary Material on Electrically modulated dynamic spreading of drops on soft surfaces Ranabir Dey 1, Ashish Daga 1, Sunando DasGupta 2,3, Suman Chakraborty 1,3 1 Department of Mechanical Engineering,

More information

Development of Molecular Dynamics Simulation System for Large-Scale Supra-Biomolecules, PABIOS (PArallel BIOmolecular Simulator)

Development of Molecular Dynamics Simulation System for Large-Scale Supra-Biomolecules, PABIOS (PArallel BIOmolecular Simulator) Development of Molecular Dynamics Simulation System for Large-Scale Supra-Biomolecules, PABIOS (PArallel BIOmolecular Simulator) Group Representative Hisashi Ishida Japan Atomic Energy Research Institute

More information

Contents. Preface XI Symbols and Abbreviations XIII. 1 Introduction 1

Contents. Preface XI Symbols and Abbreviations XIII. 1 Introduction 1 V Contents Preface XI Symbols and Abbreviations XIII 1 Introduction 1 2 Van der Waals Forces 5 2.1 Van der Waals Forces Between Molecules 5 2.1.1 Coulomb Interaction 5 2.1.2 Monopole Dipole Interaction

More information

Interfacial Flows of Contact Line Dynamics and Liquid Displacement in a Circular Microchannel

Interfacial Flows of Contact Line Dynamics and Liquid Displacement in a Circular Microchannel Proceedings of the 3 rd World Congress on Mechanical, Chemical, and Material Engineering (MCM'17) Rome, Italy June 8 10, 2017 Paper No. HTFF 159 ISSN: 2369-8136 DOI: 10.11159/htff17.159 Interfacial Flows

More information

Multiscale simulations of complex fluid rheology

Multiscale simulations of complex fluid rheology Multiscale simulations of complex fluid rheology Michael P. Howard, Athanassios Z. Panagiotopoulos Department of Chemical and Biological Engineering, Princeton University Arash Nikoubashman Institute of

More information

Computer Simulation of Particle Suspensions

Computer Simulation of Particle Suspensions Computer Simulation of Particle Suspensions Jens Harting, Martin Hecht, Hans J. Herrmann, and Sean McNamara Institute for Computational Physics, University of Stuttgart, Pfaffenwaldring 27, D-70569 Stuttgart

More information

FLOW ASSURANCE: DROP COALESCENCE IN THE PRESENCE OF SURFACTANTS

FLOW ASSURANCE: DROP COALESCENCE IN THE PRESENCE OF SURFACTANTS FLOW ASSURANCE: DROP COALESCENCE IN THE PRESENCE OF SURFACTANTS Vishrut Garg and Osman A. Basaran Davidson School of Chemical Engineering Purdue University With special thanks to: Krish Sambath (now at

More information

Gravitational effects on the deformation of a droplet adhering to a horizontal solid surface in shear flow

Gravitational effects on the deformation of a droplet adhering to a horizontal solid surface in shear flow PHYSICS OF FLUIDS 19, 122105 2007 Gravitational effects on the deformation of a droplet adhering to a horizontal solid surface in shear flow P. Dimitrakopoulos Department of Chemical and Biomolecular Engineering,

More information

dynamics of f luids in porous media

dynamics of f luids in porous media dynamics of f luids in porous media Jacob Bear Department of Civil Engineering Technion Israel Institute of Technology, Haifa DOVER PUBLICATIONS, INC. New York Contents Preface xvii CHAPTER 1 Introduction

More information

Huge-scale Molecular Study of Multi-bubble Nuclei

Huge-scale Molecular Study of Multi-bubble Nuclei Huge-scale Molecular Study of Multi-bubble Nuclei Hiroshi WATANABE 1 and Nobuyasu ITO 2 1 The Institute for Solid State Physics, The University of Tokyo, Kashiwanoha 5-1-5, Kashiwa, Chiba 277-8581, Japan

More information

Numerical simulation of wave breaking in turbulent two-phase Couette flow

Numerical simulation of wave breaking in turbulent two-phase Couette flow Center for Turbulence Research Annual Research Briefs 2012 171 Numerical simulation of wave breaking in turbulent two-phase Couette flow By D. Kim, A. Mani AND P. Moin 1. Motivation and objectives When

More information

Code Timings of a Bulk Liquid Simulation

Code Timings of a Bulk Liquid Simulation 1 Parallel Molecular Dynamic Code for Large Simulations using Truncated Octahedron Periodics M.M. Micci, L.N. Long and J.K. Little a a Aerospace Department, The Pennsylvania State University, 233 Hammond

More information

VORTEX SHEDDING PATTERNS IN FLOW PAST INLINE OSCILLATING ELLIPTICAL CYLINDERS

VORTEX SHEDDING PATTERNS IN FLOW PAST INLINE OSCILLATING ELLIPTICAL CYLINDERS THERMAL SCIENCE, Year 2012, Vol. 16, No. 5, pp. 1395-1399 1395 VORTEX SHEDDING PATTERNS IN FLOW PAST INLINE OSCILLATING ELLIPTICAL CYLINDERS by Li-Zhong HUANG a* and De-Ming NIE b a State Key Laboratory

More information

Computer Modeling of Binary Dipolar Monolayers

Computer Modeling of Binary Dipolar Monolayers Proceedings of the 8 th International Conference on Applied Informatics Eger, Hungary, January 27 30, 2010. Vol. 1. pp. 329 336. Computer Modeling of Binary Dipolar Monolayers Imre Varga a, Ferenc Kun

More information

PARALLEL PSEUDO-SPECTRAL SIMULATIONS OF NONLINEAR VISCOUS FINGERING IN MIS- Center for Parallel Computations, COPPE / Federal University of Rio de

PARALLEL PSEUDO-SPECTRAL SIMULATIONS OF NONLINEAR VISCOUS FINGERING IN MIS- Center for Parallel Computations, COPPE / Federal University of Rio de PARALLEL PSEUDO-SPECTRAL SIMULATIONS OF NONLINEAR VISCOUS FINGERING IN MIS- CIBLE DISPLACEMENTS N. Mangiavacchi, A.L.G.A. Coutinho, N.F.F. Ebecken Center for Parallel Computations, COPPE / Federal University

More information

A fast random number generator for stochastic simulations

A fast random number generator for stochastic simulations A fast random number generator for stochastic simulations Anthony J. C. Ladd Department of Chemical Engineering, University of Florida, Gainesville, Florida 32611-6005, USA Abstract A discrete random number

More information

(2.1) Is often expressed using a dimensionless drag coefficient:

(2.1) Is often expressed using a dimensionless drag coefficient: 1. Introduction Multiphase materials occur in many fields of natural and engineering science, industry, and daily life. Biological materials such as blood or cell suspensions, pharmaceutical or food products,

More information

Chemical Engineering Science

Chemical Engineering Science Chemical Engineering Science 66 (2011) 3452 3458 Contents lists available at ScienceDirect Chemical Engineering Science journal homepage: www.elsevier.com/locate/ces Contact line motion without slip in

More information

Thermocapillary Migration of a Drop

Thermocapillary Migration of a Drop Thermocapillary Migration of a Drop An Exact Solution with Newtonian Interfacial Rheology and Stretching/Shrinkage of Interfacial Area Elements for Small Marangoni Numbers R. BALASUBRAMANIAM a AND R. SHANKAR

More information

Analysis and boundary condition of the lattice Boltzmann BGK model with two velocity components

Analysis and boundary condition of the lattice Boltzmann BGK model with two velocity components Analysis and boundary condition of the lattice Boltzmann BGK model with two velocity components Xiaoyi He and Qisu Zou arxiv:comp-gas/9507002v1 22 Jul 1995 Abstract In this paper, we study the two dimensional

More information

Foundations of. Colloid Science SECOND EDITION. Robert J. Hunter. School of Chemistry University of Sydney OXPORD UNIVERSITY PRESS

Foundations of. Colloid Science SECOND EDITION. Robert J. Hunter. School of Chemistry University of Sydney OXPORD UNIVERSITY PRESS Foundations of Colloid Science SECOND EDITION Robert J. Hunter School of Chemistry University of Sydney OXPORD UNIVERSITY PRESS CONTENTS 1 NATURE OF COLLOIDAL DISPERSIONS 1.1 Introduction 1 1.2 Technological

More information

over the last few years the tantalizing

over the last few years the tantalizing Discrete Fluids over the last few years the tantalizing prospect of being able to perform hydrodynamic calculations orders-of-magnitude faster than present methods allow has prompted considerable interest

More information

CRYSTAL in parallel: replicated and distributed (MPP) data. Why parallel?

CRYSTAL in parallel: replicated and distributed (MPP) data. Why parallel? CRYSTAL in parallel: replicated and distributed (MPP) data Roberto Orlando Dipartimento di Chimica Università di Torino Via Pietro Giuria 5, 10125 Torino (Italy) roberto.orlando@unito.it 1 Why parallel?

More information

Diffuse Interface Field Approach (DIFA) to Modeling and Simulation of Particle-based Materials Processes

Diffuse Interface Field Approach (DIFA) to Modeling and Simulation of Particle-based Materials Processes Diffuse Interface Field Approach (DIFA) to Modeling and Simulation of Particle-based Materials Processes Yu U. Wang Department Michigan Technological University Motivation Extend phase field method to

More information

A simple model for block-copolymer layer morphology formation

A simple model for block-copolymer layer morphology formation A simple model for block-copolymer layer morphology formation A. J. Wagner and A. Croll, Department of Physics, North Dakota State University, Fargo, ND 58102 Prato Workshop, February 12, 2016 A big thanks

More information

Simulation of Particulate Solids Processing Using Discrete Element Method Oleh Baran

Simulation of Particulate Solids Processing Using Discrete Element Method Oleh Baran Simulation of Particulate Solids Processing Using Discrete Element Method Oleh Baran Outline DEM overview DEM capabilities in STAR-CCM+ Particle types and injectors Contact physics Coupling to fluid flow

More information

Simulation of a 3D Flow-Focusing Capillary-Based Droplet Generator

Simulation of a 3D Flow-Focusing Capillary-Based Droplet Generator Simulation of a 3D Flow-Focusing Capillary-Based Droplet Generator D. Conchouso*, E. Rawashdeh, A. Arevalo, D. Castro, I. G. Foulds King Abdullah University of Science and Technology 4700 KAUST 23955,

More information

Flow simulation of fiber reinforced self compacting concrete using Lattice Boltzmann method

Flow simulation of fiber reinforced self compacting concrete using Lattice Boltzmann method Flow simulation of fiber reinforced self compacting concrete using Lattice Boltzmann method 1 Oldřich Švec 1 * 1 Technical University of Denmark, Department of Civil Engineering, Lyngby, Denmark 2 Jan

More information

Extending Parallel Scalability of LAMMPS and Multiscale Reactive Molecular Simulations

Extending Parallel Scalability of LAMMPS and Multiscale Reactive Molecular Simulations September 18, 2012 Extending Parallel Scalability of LAMMPS and Multiscale Reactive Molecular Simulations Yuxing Peng, Chris Knight, Philip Blood, Lonnie Crosby, and Gregory A. Voth Outline Proton Solvation

More information