+ All Categories
Home > Documents > Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Date post: 07-Feb-2022
Category:
Upload: others
View: 6 times
Download: 0 times
Share this document with a friend
31
Fluctuating Hydrodynamics of Suspensions of Rigid Particles Aleksandar Donev Courant Institute, New York University Multiscale simulation methods for soft matter systems Schloss Waldthausen, Mainz, Germany Oct 6th 2014 A. Donev (CIMS) RigidIBM 10/2014 1 / 35
Transcript
Page 1: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Fluctuating Hydrodynamics ofSuspensions of Rigid Particles

Aleksandar Donev

Courant Institute, New York University

Multiscale simulation methods for soft matter systemsSchloss Waldthausen, Mainz, Germany

Oct 6th 2014

A. Donev (CIMS) RigidIBM 10/2014 1 / 35

Page 2: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Outline

1 Fluid-Particle Coupling

2 Minimally-Resolved Blob ModelOverdamped LimitResults

3 Rigid BodiesOverdamped LimitNumerical Tests

4 Outlook

A. Donev (CIMS) RigidIBM 10/2014 2 / 35

Page 3: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Fluid-Particle Coupling

Levels of Coarse-Graining

Figure: From Pep Espanol, “Statistical Mechanics of Coarse-Graining”.

A. Donev (CIMS) RigidIBM 10/2014 4 / 35

Page 4: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Fluid-Particle Coupling

Incompressible Fluctuating Hydrodynamics

The particles are immersed in an incompressible fluid that we assumecan be described by the time-dependent fluctuating incompressibleStokes equations for the velocity v (r, t),

ρ∂tv + ∇π = η∇2v + f +√

2ηkBT ∇ ·W (1)

∇ · v = 0,

along with appropriate boundary conditions.

Here the stochastic momentum flux is modeled via a randomGaussian tensor field W(r, t) whose components are white in spaceand time with mean zero and covariance

〈Wij(r, t)Wkl(r′, t ′)〉 = (δikδjl + δilδjk) δ(t − t ′)δ(r − r′). (2)

A. Donev (CIMS) RigidIBM 10/2014 5 / 35

Page 5: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Fluid-Particle Coupling

Fluid-Structure Coupling

We want to construct a bidirectional coupling between a fluctuatingfluid and a small spherical Brownian particle (blob).

Macroscopic coupling between flow and a rigid sphere:

No-slip boundary condition at the surface of the Brownian particle.Force on the bead is the integral of the (fluctuating) stress tensor overthe surface.

The above two conditions are questionable at nanoscales, but evenworse, they are very hard to implement numerically in an efficient andstable manner.

Let u be the linear and ω is angular velocity of the body, F theapplied force and τ is the applied torque, me the excess mass of thebody, and Ie the excess moment of inertia over that of the fluid.

A. Donev (CIMS) RigidIBM 10/2014 6 / 35

Page 6: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Fluid-Particle Coupling

Immersed Rigid Bodies

In the immersed boundary method we extend the fluid velocityeverywhere in the domain,

ρ∂tv + ∇π = η∇2v −∫

Ωλ (q) δ (r − q) dq +

√2ηkBT ∇ ·W

∇ · v = 0 everywhere

me u = F +

∫Ωλ (q) dq

Ieω = τ +

∫Ω

[q× λ (q)] dq

v (q, t) = u + q× ω

=

∫v (r, t) δ (r − q) dr for all q ∈ Ω,

where the induced fluid-body force [1] λ (q) is a Lagrangemultiplier enforcing the final no-slip condition (rigidity).

A. Donev (CIMS) RigidIBM 10/2014 7 / 35

Page 7: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Fluid-Particle Coupling

Overdamped Limit

Ignoring fluctuations, for viscous-dominated flow we can switch tothe steady Stokes equation.

The result is a linear mapping or extended mobility matrix M,

[U , Ω]T = M [F , T ]T ,

where the left-hand side collects the linear and angular velocities, andthe right hand side collects the applied forces.

When the inertia-free or overdamped limit is taken carefully, anoverdamped Langevin equation for the positions Q andorientations Θ of the bodies emerge.

Fluctuation-dissipation balance needs to be studied morerigorously, but see Hinch and especially work by Roux [2].

Problem: How to compute M and the simulate the Brownianmotion of the particles?

A. Donev (CIMS) RigidIBM 10/2014 8 / 35

Page 8: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model

Brownian Particle Model

Consider a Brownian “particle” of size a with position q(t) andvelocity u = q, and the velocity field for the fluid is v(r, t).

We do not care about the fine details of the flow around a particle,which is nothing like a hard sphere with stick boundaries in realityanyway.

Take an Immersed Boundary Method (IBM) approach and describethe fluid-blob interaction using a localized smooth kernel δa(∆r) withcompact support of size a (integrates to unity).

Often presented as an interpolation function for point Lagrangianparticles but here a is a physical size of the particle (as in the ForceCoupling Method (FCM) of Maxey et al).

We will call our particles “blobs” since they are not really pointparticles.

A. Donev (CIMS) RigidIBM 10/2014 10 / 35

Page 9: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model

Local Averaging and Spreading Operators

Postulate a no-slip condition between the particle and local fluidvelocities,

q = u = [J (q)] v =

∫δa (q− r) v (r, t) dr,

where the local averaging linear operator J(q) averages the fluidvelocity inside the particle to estimate a local fluid velocity.The induced force density in the fluid because of the force F appliedon particle is:

f = −Fδa (q− r) = − [S (q)] F,

where the local spreading linear operator S(q) is the reverse (adjoint)of J(q).The physical volume of the particle ∆V is related to the shape andwidth of the kernel function via

∆V = (JS)−1 =

[∫δ2a (r) dr

]−1

. (3)

A. Donev (CIMS) RigidIBM 10/2014 11 / 35

Page 10: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model

Many-Particle Systems

Denote composite vector of positions Q = q1, . . . ,qN andΘ = θ1, . . . ,θN the orientations of all of the N blobs.

Composite velocity U = u1, . . . ,uN andangular velocity Ω = ω1, . . . ,ωN.Applied forces F (Q) = F1 (Q) , . . . ,FN (Q),applied torques T = τ 1, . . . , τN.Define composite local averaging linear operator J (Q) operator, isthe composite spreading linear operator, S (Q) = J ? (Q),

(J v)i =

∫δa (qi − r) v (r, t) dr

(SF) (r) =N∑i=1

Fiδa (qi − r) .

A. Donev (CIMS) RigidIBM 10/2014 12 / 35

Page 11: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model

Inertial Equations of Motion

The momentum equation, ∇ · v = 0 and

ρ∂tv + ∇π = η∇2v +√

2ηkBT ∇ ·W + SF +1

2∇× (ST ) + fth.

The suspended particles are prescribed to follow the local fluidmotion, leading to the N minimally-resolved no-slip conditions

U = dQ/dt = J v, (4)

Ω = dΘ/dt = ∇× (J v) /2.

Henceforth we will not include rotation and only consider translationalDOFs.

A. Donev (CIMS) RigidIBM 10/2014 13 / 35

Page 12: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model

Fluctuation-Dissipation Balance

One must ensure fluctuation-dissipation balance in the coupledfluid-particle system: our equations are ergodic with respect to theGibbs-Boltzmann distribution [3]

Peq (Q,Θ) ∼ exp (−U (Q,Θ) /kBT ) ,

where F = −∂QU and T = −∂ΘU.

No entropic contribution to the coarse-grained free energy becauseour formulation is isothermal and the particles do not have internalstructure.

In order to ensure that the dynamics is ergodic with respect to anappropriate Gibbs-Boltzmann distribution), add the thermal orstochastic drift forcing [4, 3, 5]

fth = (kBT ) ∂Q · S (Q) . (5)

A. Donev (CIMS) RigidIBM 10/2014 14 / 35

Page 13: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model Overdamped Limit

Overdamped Limit

Let us assume that the Schmidt number is very large,

Sc = η/ (ρχ) 1,

where χ ≈ kBT/ (6πηa) is a typical value of the diffusion coefficientof the particles.

To obtain the asymptotic dynamics in the limit Sc→∞ heuristically,we delete the inertial term ρ∂tv in (1), ∇ · v = 0 and

∇π = η∇2v + SF +√

2ηkBT ∇ ·W ⇒ (6)

v = η−1L−1(SF +

√2ηkBT ∇ ·W

),

where L−1 0 is the Stokes solution operator.

A. Donev (CIMS) RigidIBM 10/2014 15 / 35

Page 14: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model Overdamped Limit

Overdamped Limit

A rigorous adiabatic mode elimination procedure informs us that thecorrect interpretation of the noise term in this equation is the kineticstochastic integral,

dQ (t)

dt= J (Q)L−1

[1

ηS(Q)F(Q) +

√2kBT

η∇ W (r, t)

]. (7)

This is equivalent to the standard equations of Brownian Dynamics(BD),

dQ

dt= MF + (2kBTM)

12 W(t)+kBT (∂Q ·M), (8)

where M(Q) 0 is the symmetric positive semidefinite (SPD)mobility matrix

M = η−1JL−1S.

A. Donev (CIMS) RigidIBM 10/2014 16 / 35

Page 15: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model Overdamped Limit

Brownian Dynamics via Fluctuating Hydrodynamics

It is not hard to show that M is very similar to the Rotne-Pragermobility used in BD, for particles i and j ,

Mij = η−1

∫δa(qi − r)K(r, r′)δa(qj − r′) drdr′ (9)

where K is the Green’s function for the Stokes problem (Oseentensor for infinite domain).

The self-mobility defines a consistent hydrodynamic radius of a blob,

Mii = Mself =1

6πηaI.

For well-separated particles we get the correct Faxen correction,

Mij ≈ η−1

(I +

a2

6∇2

r

)(I +

a2

6∇2

r′

)K(r − r′)

∣∣r=qj

r′=qi.

At smaller distances the mobility is regularized in a natural way andpositive-semidefiniteness ensured automatically.

A. Donev (CIMS) RigidIBM 10/2014 17 / 35

Page 16: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model Overdamped Limit

Numerical Methods

Both compressible and incompressible, inertial and overdamped,numerical methods have been implemented by Florencio Balboa(UAM) on GPUs for periodic BCs (public-domain!), and in theparallel IBAMR code of Boyce Griffith by Steven Delong for generalboundary conditions (to be made public-domain next fall!).

Spatial discretization is based on previously-developed staggeredschemes for fluctuating hydro [6] and the immersed-boundarymethod kernel functions of Charles Peskin.

Temporal discretization follows a second-order splitting algorithm(move particle + update momenta), and is limited in stability only byadvective CFL.

We have constructed specialized temporal integrators that ensurediscrete fluctuation-dissipation balance, including for theoverdamped case.

A. Donev (CIMS) RigidIBM 10/2014 18 / 35

Page 17: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model Overdamped Limit

(Simple) Midpoint Scheme

Fluctuating Immersed Boundary Method (FIBM) method:

Solve a steady-state Stokes problem (here δ 1)

∇πn = η∇2vn +√

2ηkBT ∇ ·Zn + SnF (qn)

+kBT

δ

[S(

qn +δ

2W

n)− S

(qn − δ

2W

n)]

Wn

∇ · vn = 0.

Predict particle position:

qn+ 12 = qn +

∆t

2J nv

Correct particle position,

qn+1. = qn + ∆tJ n+ 12 v.

A. Donev (CIMS) RigidIBM 10/2014 19 / 35

Page 18: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model Results

Slit Channel

0 10 20 30 40 50 60H/a

0.00

0.02

0.04

0.06

0.08

0.10

0.12

0.14

0.16PD

F ×a

Euler-Maruyama (biased)MidpointBiased DistributionGibbs Boltzmann

Figure: Probability distribution of the distance H to one of the walls for afreely-diffusing blob in a two dimensional slit channel.

A. Donev (CIMS) RigidIBM 10/2014 20 / 35

Page 19: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Minimally-Resolved Blob Model Results

Colloidal Gellation: Cluster collapse

10-2

10-1

100

101

102

t / tB = t kBT / ηa3

6.0

6.2

6.4

6.6

6.8

7.0

7.2

7.4R

gBD with HIBD without HIFIBM (4pt, IBAMR)FIBM (3pt, fluam)

Figure: Relaxation of the radius of gyration of a colloidal cluster of 13 spherestoward equilibrium, taken from Furukawa+Tanaka.

A. Donev (CIMS) RigidIBM 10/2014 21 / 35

Page 20: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies

Blob/Bead Models

Figure: Blob or “raspberry”models of: a spherical colloid, and a lysozyme [7].

A. Donev (CIMS) RigidIBM 10/2014 23 / 35

Page 21: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies

Review: Immersed Rigid Bodies

In the immersed boundary method we extend the fluid velocityeverywhere in the domain,

ρ∂tv + ∇π = η∇2v −∫

Ωλ (q) δ (r − q) dq +

√2ηkBT ∇ ·W

∇ · v = 0 everywhere

me u = F +

∫Ωλ (q) dq

Ieω = τ +

∫Ω

[q× λ (q)] dq

v (q, t) = u + q× ω

=

∫v (r, t) δ (r − q) dr for all q ∈ Ω,

where the induced fluid-body force [1] λ (q) is a Lagrangemultiplier enforcing the final no-slip condition (rigidity).

A. Donev (CIMS) RigidIBM 10/2014 24 / 35

Page 22: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies

Rigid-Body Immersed-Boundary Method

A neutrally-buoyant rigid-body immersed boundary formulationusing blobs:

ρ∂tv + ∇π = η∇2v − SΛ +√

2ηkBT ∇ ·W + fth

∇ · v = 0 (Lagrange multiplier is π)∑i

λi = F (Lagrange multiplier is u) (10)∑qi × λi = τ (Lagrange multiplier is ω), (11)

J v = u + ω ×Q + slip (activity)

where Λ = λ1, . . . ,λN are the unknown rigidity forces on eachblob that need to be solved for (this is the hard part!).

1 Specified kinematics (e.g., swimming object): Unknowns are v, π andΛ, while F and τ are outputs (easier).

2 Free bodies (e.g., colloidal suspension): Unknowns are v, π and Λ, uand ω, while F and τ are inputs (harder).

A. Donev (CIMS) RigidIBM 10/2014 25 / 35

Page 23: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies Overdamped Limit

Rigid-Body Langevin Dynamics

This system of equations (once fth is determined) is ergodic wrt theGibbs-Boltzmann distribution.

The many-body mobility matrix N takes into account higher-orderhydrodynamic interactions,

N =(KM−1K?

)−1,

relating the total applied forces and torques with the resulting linearand angular velocities.Here K is a simple geometric matrix, defined viaK? [U,Ω]T = U + Ω×Q.

This works for confined systems, non-spherical particles, and evenactive particles.Can also be extended to semi-rigid structures (e.g., bead-linkpolymer chains).

A. Donev (CIMS) RigidIBM 10/2014 26 / 35

Page 24: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies Overdamped Limit

Overdamped Limit

The overdamped limit can be taken and amounts to (aside fromthermal drift terms) to simply deleting ρ∂tv, to get[

]= N

([FT

]+

√2kBT

ηKM−1JL−1∇ W

)= (12)

= N[FT

]+ (2kBTN )

12 ∇ W

Observe the noise automatically has the right covariance,

N12

(N

12

)?= NKM−1

(JL−1LL−1S

)M−1K?N ,

= N(KM−1K

)N = N

without any approximations and for all types of boundary conditions.

A. Donev (CIMS) RigidIBM 10/2014 27 / 35

Page 25: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies Numerical Tests

Shell-in-Shell Test

Figure: Error in the velocity and pressure for different resolutions. (Left) Outer:162, Inner: 12 blobs. (Right) Outer: 642, Inner: 42 blobs.

A. Donev (CIMS) RigidIBM 10/2014 28 / 35

Page 26: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies Numerical Tests

Steady Stokes Test

Figure: Error in the velocity and pressure for different resolutions. (Left) Outer:2562, Inner: 162 blobs. (Right) Outer: 10242, Inner: 642 blobs.

A. Donev (CIMS) RigidIBM 10/2014 29 / 35

Page 27: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies Numerical Tests

Alternative Discretizations

Figure: Error in the velocity and pressure for shell-in-shell steady Stokes test withdouble-shell.

A. Donev (CIMS) RigidIBM 10/2014 30 / 35

Page 28: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies Numerical Tests

Sphere in Shear Flow

The low-order moments of the fluid-particle stress convergerelatively rapidly.

The total drag (zeroth moment) and torque (antisymmetric part ofthe second moment),

F =∑i

Λi and τ =∑i

λi × ri .

These are nonzero and consistent even for a single blob.

But to get a nonzero stresslet (symmetric part of the secondmoment) we need a raspberry-type model,

S = SymmTraceless

∑i

λi ⊗ ri

.

A. Donev (CIMS) RigidIBM 10/2014 31 / 35

Page 29: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Rigid Bodies Numerical Tests

Accuracy

Compare to theoretical formulae to derive an effective hydrodynamicradius:

T = 8πµR3ω where ω = (∇× v) /2 (13)

S =10π

3ηR3γ where γ = ∇v + ∇Tv.

# blobs Drag Rh Torque Rτ Stresslet Rs Geom Rg

12 1.4847 1.3774 1.4492 1

42 1.2152 1.1671 1.2474 1

162 1.0864 1.0730 1.0959 1

642 1.0377 1.0343 1.0405 1

2562 1.0172 1.0163 1.0184 1

Table: Hydrodynamic radii for several resolutions of shell sphere models.

A. Donev (CIMS) RigidIBM 10/2014 32 / 35

Page 30: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Outlook

Conclusions

Fluctuating hydrodynamics seems to be a very good coarse-grainedmodel for fluids, and coupled to immersed particles to modelBrownian suspensions (model can be justified microscopically,ongoing work with Pep Espanol).

The minimally-resolved blob approach provides a low-cost butreasonably-accurate representation of rigid particles in flow (has beenextended to reaction-diffusion problems).

Particle and fluid inertia can be included in the description, or, anoverdamped limit can be taken if Sc 1.

More complex particle shapes can be built out of a collection ofblobs to form a rigid body.

A postdoc position is available in my group:Fluctuating Hydrodynamics of chemically reactive + multiphase +multispecies liquid mixtures

A. Donev (CIMS) RigidIBM 10/2014 34 / 35

Page 31: Fluctuating Hydrodynamics of Suspensions of Rigid Particles

Outlook

References

D. Bedeaux and P. Mazur.

Brownian motion and fluctuating hydrodynamics.Physica, 76(2):247–258, 1974.

J. N. Roux.

Brownian particles at different times scales: a new derivation of the Smoluchowski equation.Phys. A, 188:526–552, 1992.

F. Balboa Usabiaga, R. Delgado-Buscalioni, B. E. Griffith, and A. Donev.

Inertial Coupling Method for particles in an incompressible fluctuating fluid.Comput. Methods Appl. Mech. Engrg., 269:139–172, 2014.Code available at https://code.google.com/p/fluam.

P. J. Atzberger.

Stochastic Eulerian-Lagrangian Methods for Fluid-Structure Interactions with Thermal Fluctuations.J. Comp. Phys., 230:2821–2837, 2011.

S. Delong, F. Balboa Usabiaga, R. Delgado-Buscalioni, B. E. Griffith, and A. Donev.

Brownian Dynamics without Green’s Functions.J. Chem. Phys., 140(13):134110, 2014.

F. Balboa Usabiaga, J. B. Bell, R. Delgado-Buscalioni, A. Donev, T. G. Fai, B. E. Griffith, and C. S. Peskin.

Staggered Schemes for Fluctuating Hydrodynamics.SIAM J. Multiscale Modeling and Simulation, 10(4):1369–1408, 2012.

Jose Garcıa de la Torre, Marıa L Huertas, and Beatriz Carrasco.

Calculation of hydrodynamic properties of globular proteins from their atomic-level structure.Biophysical Journal, 78(2):719–730, 2000.

A. Donev (CIMS) RigidIBM 10/2014 35 / 35


Recommended