Skip to main content
NIHPA Author Manuscripts logoLink to NIHPA Author Manuscripts
. Author manuscript; available in PMC: 2020 Nov 15.
Published in final edited form as: J Comput Phys. 2019 Jul 18;397:108830. doi: 10.1016/j.jcp.2019.07.029

Two Relaxation Time Lattice Boltzmann Method Coupled to Fast Fourier Transform Poisson Solver: Application to Electroconvective Flow

Yifei Guan 1, Igor Novosselov 1,§
PMCID: PMC6711381  NIHMSID: NIHMS1537212  PMID: 31456595

Abstract

Electroconvective flow between two infinitely long parallel electrodes is investigated via a multiphysics computational model. The model solves for spatiotemporal flow properties using two-relaxation-time Lattice Boltzmann Method for fluid and charge transport coupled to Fast Fourier Transport Poisson solver for the electric potential. The segregated model agrees with the previous analytical and numerical results providing a robust approach for modeling electrohydrodynamic flows.

Keywords: Two-Relaxation-Time Lattice Boltzmann Method, Fast Poisson Solver, Electroconvection Stability

III. INTRODUCTION

Electro-hydrodynamics (EHD) studies the interaction of the fluid with electric field [1]. As a subset of EHD, electroconvection (EC) is a phenomenon where convective transport is induced by unipolar discharge into a dielectric fluid [2-21]. Felici first performed a stability analysis of EC using a non-linear hydraulic model [22, 23]. Linear stability analysis was investigated by Schneider & Watson [24, 25] and Atten & Moreau [26], who showed that, in the weak-injection limit, C ≪ 1, where C is the charge injection, the flow stability is determined by the criterion TcC2, where Tc is the linear stability threshold for the electric Rayleigh number (T) – a ratio between electric force to the viscous force. In the space-charge-limited (SCL) injection (C→∞), the flow stability is determined by Tc. Experimental observations of Lacroix et al. [27] and Atten et al. [28] showed that, in the SLC limit, Tc = 100 [28], while linear stability analysis suggests Tc=160.45 for the same conditions [26]. Authors suggest that the discrepancy is due to the omission of the charge diffusion term in the analysis [29]. The effect of charge diffusion was investigated by Zhang et al., who performed a linear stability analysis [12] followed by a non-linear analysis using the multiscale method [17]. Zhang et al. found that the charge diffusion has a non-negligible effect on Tc, but their analysis could not bridge the discrepancy between the experimental and theoretical values.

To gain insight into the flow-charge interaction, the EC problem has been investigated by numerical methods. Castellanos and Atten used a finite difference model, concluding that large numerical diffusivity can contaminate the model [3]. Other numerical models used to study EC phenomena include the particle-in-cell method [30], finite volume method with flux-corrected transport [31], total variation diminishing scheme [5, 8, 14-16], and the method of characteristic [4]. Recently, Luo et al. showed that a unified Lattice Boltzmann model (LBM) matches the linear and finite amplitude stability criteria of the subcritical bifurcation in EC flow [18-21] for both 2D and 3D flow scenarios. This unified LBM transforms the elliptic Poisson equation to a parabolic advection-diffusion equation and introduces artificial coefficients to control the evolution of the electric potential, which requires additional sub-iterations at each time step.

In this paper, we demonstrate an alternative approach to modeling EC flow; our segregated solver combines (i) a two-relaxation-time (TRT) LBM [32-41] for modeling fluid transport and charged species, (ii) a Fast Fourier Transform (FFT) [42-45] Poisson approach for solving for the electric field directly. The TRT model introduces two relaxation parameters aiding the numerical algorithm stability without sacrificing computational efficiency. The TRT model is parameterized with physical units without rescaling to lattice units.

IV. NUMERICAL METHOD

1. Governing Equations

The governing equations for EHD flow include the Navier-Stokes equations (NSE), with the addition of an electric forcing term Fe = ρcφ to the momentum equation, the charge transport equation, and the Poisson equation for electric potential.

u=0, (1)
ρDuDt=P+μ2uρcφ, (2)
ρct+[(uμbφ)ρcDcρc]=0, (3)
2φ=ρcε, (4)

where ρ is the density, μ - dynamic viscosity, u = (ux, uy) - velocity vector field, P - static pressure, μb - mobility, Dc - ion diffusivity, ρc - charge density, ε - electric permittivity, φ - electric potential. The electric force provides a source term in the momentum equation (Eq. 2). The unknown properties are velocity field u, pressure P, charge density ρc, and electric potential φ.

2. Lattice Boltzmann Method

The TRT-LBM is applied to NSE (Eq. 1-2) and the transport equation for charge density (Eq. 3). The mesoscopic solutions of the LBM yield a discrete distribution function of velocity fi(x, t) and charge density gi(x, t). The values of ρ, ρc, and momentum density ρu can be evaluated by weighted sums.

ρ(x,t)=ifi(x,t), (5)
ρc(x,t)=igi(x,t), (6)
ρu(x,t)=icifi(x,t)+FeΔt2=icifi(x,t)ρcφΔt2, (7)

The discrete normalized velocity, ci = (cix, ciy) at position - x and time - t depends on a specific discretization scheme; here, we use the D2Q9 model (two spatial dimensions and nine discrete velocities). The spatial discretization is uniform (∆x = ∆y ), and the temporal discretization - ∆t. The ci parameters (i=0~8) are shown in the Supplementary Material. Keeping the temporal discretization term allows for temporal accuracy control and to perform dynamic analysis. For example, in the analysis of electroconvection stability using Dynamic Mode Decomposition (DMD), it was found that the model performance is dependent on temporal discretization value [47]; thus it can be beneficial to explicitly include the ∆t in the formulation. The SI units are used for macroscopic variables and discretization, e.g., ∆x is given in meters and ∆t in seconds.

The Lattice Boltzmann Equations (LBEs) for flow field and charge density are:

fi(x+ciΔt,t+Δt)=fi(x,t)Δt[ω+(fi+fieq+)+ω(fifieq)]TRTcollisionoperator+Δt[(1ω+Δt2)Fi+(x,t)+(1ωΔt2)Fi(x,t)]TRTsourceoperator, (8)
gi(x+ciΔt,t+Δt)=gi(x,t)Δt[ωg+(gi+gieq+)+ωg(gigieq)]TRTcollisionoperator, (9)

fieq and gieq are the equilibrium distributions for flow field and charges respectively, which are given by

fieq(x,t)=wiρ(1+ucics2+(uci)22cs4uu2cs2), (10)
gieq(x,t)=wiρc(1+(uμbφ)cics2+[(uμbφ)ci]22cs4(uμbφ)(uμbφ)2cs2), (11)

Fi is the forcing term accounting for the electric force

Fi=wi(ciucs2+(ciu)cics4)Fe (12)

where cs2=Pρ=(13)(ΔxΔt)2 is the speed of sound [32, 33, 35, 36, 48], which is commonly set to be cs2=13 in lattice units (∆x = ∆y = ∆t = 1); however, since the model is parameterized, and the ∆t is explicitly included in the formulation, cs2 has to be scaled depending on the choice of ∆x and ∆t as shown in the supplementary materials. τ±=1ω± and τg±=1ωg± are the times at which the distribution functions relax to equilibrium, and wi is the weight for the velocity component ci, the values are provided in the supplementary materials. The values of cs are tunable, especially in Eq. 11 [37, 39, 40]; they are set to be the same because of the adopted equilibrium form. The values of wi (Eq. 11) are not restricted to the choice of wi in Eq. 10. Since Eq.3 is isotropic and in the case of simple rectangular geometry, the reduced coordinate stencil D2Q5 can be appealing [40, 41]. The use of the coordinate stencil may be also beneficial for implementation of bounce-back Neumann condition at the walls. However, as noted by Ginzburg, the full-weight stencils are attractive because of their stability and anisotropy [41, 49]. As suggested by Luo et al., the D2Q9 model is used in the current work to model the charge transport equation [18]. Since the isotropic hydrodynamic weight is used to enable the isotropy of the high-order corrections [37, 39], D2Q9 can be reduced to D2Q5 to enhance the performance [40, 41].

The TRT approach has been previously used to model the collision operators [32-34, 37-41] and the momentum source operator [50, 51]. Alternatively, to SRT operators, TRT is more robust for EC problems, as it provides additional relaxation parameter, improving the numerical stability [48]. The terms specified in the TRT collision operators and the source operator are

fi+=fi+fi2,fi=fifi2,fieq+=fieq+fieq2,fieq=fieqfieq2 (13)
gi+=gi+gi2,gi=gigi2,gieq+=gieq+gieq2,gieq=gieqgieq2 (14)
Fi±=Fi±Fi2 (15)

Subscript i¯ denotes the velocity component opposite to i , such that ci=ci¯. Symmetric relaxation parameters ω+ and antisymmetric ωg are determined by the viscosity and diffusivity respectively [35, 36, 52]:

v=cs2(1ω+Δt2),Dc=cs2(1ωgΔt2). (16)

ω and ωg+ need to satisfy

Λ=Λ+Λ=(1ω+Δt12)(1ωΔt12),Λg=Λg+Λg=(1ωg+Δt12)(1ωgΔt12), (17)

where Λ and Λg are free factors used to control the algorithm stability [48]. Here, Λ = 1/12 and Λg = 10−6; the large difference accounts for the mismatch between the neutral molecule and charge diffusivity. The Λ = 1/12 is chosen for the accuracy in solving the flow equation, and the choice of Λg = 10−6 is used for the accuracy of solving the electric properties in the domain; error analysis is included in the supplementary materials. Ginzburg and colleagues also suggested that the choice of Λg+=Λg=112 suppresses the third-order error in advection-diffusion equations[36, 37, 39, 49].

3. Fast Poisson Solver

The Poisson equation (Eq. 4) is directly solved by a fast Poisson solver using a 2D FFT algorithm. This solver does not use an artificial time-stepping term in solving the elliptical equation as previously proposed by the unified LBM model [18-21]. The discretized grid function can be written as:

[Dx2+Dy2]φx,y=sx,y (18)

where Dx2 and Dy2 are 2nd order derivatives operators in x - y coordinates; sx,y - source term representing space charge effect. Fourier spectral method is used in the x-direction and 2nd order finite difference scheme in the y-direction. In x-direction, the FFT algorithm is used to implement the standard Discrete Fourier transform (DFT).

DFTx[φx,y]=x=1NXφx,yexp[i2π(kx1)NX(x1)],1kxNX. (19)

where kx is the wavenumber and NX is the number of grid points in the x-direction. The 2nd derivative in the x-direction can be calculated in the Fourier domain

DFTx[Dx2φx,y]=DFTx[2φx,yx2]=kx2DFTx[φx,y]. (20)

Fourier transform in the y-direction uses an odd extension of the domain to satisfy the Dirichlet boundary conditions.

φx,yextext=[0,φx,1,φx,2,,φx,Ny,0,φx,Ny,,φx,1], (21)
sx,yextext=[0,sx,1,sx,2,,sx,Ny,0,sx,Ny,,sx,1], (22)

where NY is the number of grid points in the y-direction. The size of the extended matrices is NX×NE, where NE = 2NY + 2 ; the yext is the extended y indices, ranging from 1 to NE.

From the definition of DFT (Eq.19), we have:

DFTy[φx,y+1s]=exp(ikyΔy)DFTy[φx,y], (23)

where φs is a periodically shifted vector by ∆y of φ in y-direction. Applying a central differencing operator in yext direction gives:

DFTyext[Dyext2φx,yextext]=exp(ikyextΔy)+exp(ikyextΔy)2Δy2DFTyext[φx,yextext]=4sin2(kyextΔy2)Δy2DFTyext[φx,yextext]. (24)

Therefore, the Fourier transform of Eq.18 is

(kx2+4sin2(kyextΔy2)Δy2)DFTx,yext[φkx,kyextext]=DFTx,yext[skx,kyextext] (25)

The Inverse Fast Fourier Transform (IFFT) algorithm transforms DFTx,yext[φkx,kyextext] into the spatial domain. Then, the electric potential in the original domain is obtained by retaining the first half (1 ≤ yNy) of the extended solution matrix. In principle, TRT solver can replace the Poisson solver by employing the sub-iterations within each time step [53, 54], which may be beneficial for problems with complex geometries. However, in the case with periodic boundaries, the FFT method is a more efficient choice of solving for the electric potential.

4. Boundary Conditions and Method Implementation

The numerical method is implemented in C++ using CUDA GPU computing. The number of threads in the x-direction in each GPU block is equal to NX; the number of GPU blocks in the y-direction is equal to NY. FFT and IFFT operations are performed using the cuFFT library. All variables are computed with double precision to reduce truncation errors. The numerical method was shown to be 2nd order accurate in space. Error analysis is provided in supplementary materials. To reduce computational cost while maintaining accuracy, the grid of NX = 122, NY = 100 is used throughout this work. Macroscopic and mesoscopic boundary conditions are specified in Table I.

Table I.

Boundary conditions used in the numerical simulations.

Boundary Macro-variables Conditions Meso-variables Conditions
x direction boundaries Periodic Periodic
Upper wall u = 0, φ = 0 and ∆ρc = 0 Bounce-back for fi [32, 38, 40, 41,48]
Bounce-back for gi [32, 38, 40, 41, 48]
Lower wall u=0, φ=φ0 and ρc = ρ0 Bounce-back for fi
giz=0

The full-way bounce-back is used for Dirichlet boundary conditions for fluid flow [18, 19, 55]. The bounce-back method for Neumann boundary conditions applied to impermeable solid walls can introduce spurious boundary layer because of the diagonal velocity-weights [40, 41]. Nevertheless, The Neumann boundary condition for gi is an outflow boundary condition for charge density transport [18, 19, 48]. The choice of small Λg ⊄ can improve accuracy because of the horizontal boundaries [40, 41].

V. RESULT AND DISCUSSION

1. Non-dimensional Analysis and Solution for Hydrostatic State

Governing equations yield four non-dimensional parameters that describe the system’s state [12, 17-21].

M=(ερ)12μb,T=εΔφ0μμb,C=ρ0H2εΔφ0,Fe=μbΔφ0De, (26)

where H is the distance between the electrodes (distance between the two infinite plates), ρ0 is the injected charge density at the anode, and ∆φ0 is the voltage difference applied to the electrodes. The physical interpretation of these parameters are as follows: M- the ratio between hydrodynamic mobility and the ionic mobility; T- the ratio between electric force to the viscous force; C- the charge injection level; and Fe- the reciprocal of the charge diffusivity coefficient [12, 17]. For electroconvection system considered in this paper, these four non-dimensional parameters can characterize the flow. Velocity is not explicitly included; however, for the scenarios with strong advection, a different set of scaling parameters can be more attractive [46, 56].

FIG. 1 shows that our hydrostatic solutions for electric field and charge density agree well with the model of Luo et al. [18, 19] and the analytical solution [30, 57]. The analytical solution is based on a reduced set of equations for the electric field in one-dimensional coordinates.

ρc=ρa(y+ya)12, (27)
Ey=2ρaε(y+ya)12, (28)

where ρa and ya are parameters that depend on the boundary conditions and geometry. For the hydrostatic state, parameter C dominates the system [12, 17].

FIG. 1.

FIG. 1.

Hydrostatic solution comparison of the TRT LBM and Fast Poisson solver, unified SRT LBM [18], and the analytical solution [30, 57] for C = 0.1 and C = 10, Fe = 4000. (a) Electric field and (b) charge density;

Table II shows the dimensional parameters used for the analytical solution and the L2 norm error between numerical results and analytical solutions. The numerical errors are lower than reported for the unified SRT LBM simulation (eL2 =0.0076) [18].

Table II.

Dimensional parameters for the analytical model and L2 norm errors eL2 for weak ion injection C = 0.1 and strong ion injection C = 10.

C 0.1 10
ρa (Coulomb / m5/2) 0.218 0.75
ya (m) 4.8 0.003
eL2 of Ey 0.0031 0.0030
eL2 of ρc 0.0035 0.0031

2. Electroconvection Instability

To model electro-convective instability, the steady-state hydrostatic solution is perturbed using waveform functions that satisfy the boundary conditions and continuity equation:

ux=Lxsin(2πyLy)sin(2πxLx)×103uy=Ly[cos(2πyLy)1]cos(2πxLx)×103. (29)

The physical domain size is Lx = 1.22m and Ly = 1m limits the perturbation wavenumber to λx = 2π/Lx ≈ 5.15(1/m) -- the most unstable mode under the condition, where C = 10, M = 10, Fe = 4000 [19]. The electric Nusselt number Ne0 = I1 / I0 acts as a criterion of flow stability, where I1 is the cathode current at a specific condition, I0 is the cathode current for the hydrostatic solution [5]. For cases where EC vortices exist, Ne0 > 1. For a strong ion injection, the EC stability largely depends on T; so, in this analysis, T is varied, while other parameters are held constant: C = 10, M = 10 and Fe = 4000.

For TTc and the perturbation is given by Eq. 29, the flow becomes unstable developing EC vortices which are maintained by an electric force acting on the ionized fluid -- a combination of applied electric field and the space charge effect. The space charge effect can alter the applied electric field in the area of high charge density [56]. FIG. 2 (a) shows the formation of counter-rotating vortices; the charge density contour plotted with streamlines. In an upward fluid motion, the local charge transport is enhanced as indicated by the higher charge density in the center of the domain. In downward flow motion, the charge transport decreases, see the darker blue in the edges of the domain. FIG. 2 (b) shows the x-directional velocity contour. High x-velocity regions are located near the top and bottom walls; the flow is symmetric, which indicates that the steady-state solution has the same wavelength in x and y directions as the perturbation equations (Eq. 29).

FIG. 2.

FIG. 2.

Charge density and ux contours for EHD convection with vortices.

FIG. 3 (a) shows the EC flow stability analysis, demonstrated by Ne0 as a function of T. When T < Tc the perturbation does not trigger the flow instability, the perturbed flow reverses to the hydrostatic state. If T decreases after the EC vortices are formed, they are maintained until T = Tf when the system returns to the hydrostatic state. The model predicts the bifurcation points at Tc = 163.4 and Tf = 108.7 agreeing Luo et al. [19] (Tc = 163.1, Tf = 108.7 ), the linear stability analysis [12, 19] (Tc = 163.5), and the finite volume method [16] (Tf = 108.2 ) under the same conditions. Neither numerical model or linear stability analysis agree with the experimental data. The proposed segregated TRT-LBM approach is consistent with the previous research; however, it does not modify governing equations by introducing artificial terms needed for numerical stability and yields fast convergence of the elliptical Poisson equation enabled for the FFT approach.

FIG. 3.

FIG. 3.

Electric Nusselt number Ne0 depends on electric Rayleigh number T

VI. CONCLUSIONS

This work presents a numerical investigation of electroconvection phenomena between two parallel plates. The numerical approach combines (i) TRT-LBM for solving the transport equation of flow field and charged species, and (ii) Fast Poisson Solver. The TRT model allows for the use of two relaxation parameters, accounting for the difference between the transport properties of neutral molecules and charged species. The choice of relaxation parameters allows for both accuracy and stability over a wide variety of conditions. FFT algorithm for Poisson’s equation directly solves for electric field enabling fast overall algorithm convergence. The numerical method is 2nd order accurate; it shows robust performance and agrees with previous results for the hydrostatic solution and for the solution where EC vortices are present.

Supplementary Material

1

VII. ACKNOWLEDGMENTS

This research was supported by DHS Science and Technology Directorate, and UK Home Office; contract no. HSHQDC-15-C-B0033 and by the National Institutes of Health, (grant numbers: NIBIB U01 EB021923, NIBIB R42ES026532 subcontract to UW)

Footnotes

Publisher's Disclaimer: This is a PDF file of an unedited manuscript that has been accepted for publication. As a service to our customers we are providing this early version of the manuscript. The manuscript will undergo copyediting, typesetting, and review of the resulting proof before it is published in its final citable form. Please note that during the production process errors may be discovered which could affect the content, and all legal disclaimers that apply to the journal pertain.

Declaration of interests

The authors declare that they have no known competing financial interests or personal relationships that could have appeared to influence the work reported in this paper.

VIII. REFERENCES

  • [1].Castellanos A, Electrohydrodynamics (Springer, 2014), Vol. 380. [Google Scholar]
  • [2].Malraison B and Atten P, Chaotic behavior of instability due to unipolar ion injection in a dielectric liquid, Physical Review Letters 49, 723 (1982). [Google Scholar]
  • [3].Castellanos A and Atten P, Numerical modeling of finite amplitude convection of liquids subjected to unipolar injection, IEEE transactions on industry applications, 825 (1987). [Google Scholar]
  • [4].Adamiak K and Atten P, Simulation of corona discharge in point–plane configuration, Journal of electrostatics 61, 85 (2004). [Google Scholar]
  • [5].Traoré P and Pérez A, Two-dimensional numerical analysis of electroconvection in a dielectric liquid subjected to strong unipolar injection, Physics of Fluids 24, 037102 (2012). [Google Scholar]
  • [6].Kwak R, Pham VS, Lim KM, and Han J, Shear flow of an electrically charged fluid by ion concentration polarization: scaling laws for electroconvective vortices, Physical review letters 110, 114501 (2013). [DOI] [PubMed] [Google Scholar]
  • [7].Traoré P and Wu J, On the limitation of imposed velocity field strategy for Coulomb-driven electroconvection flow simulations, Journal of Fluid Mechanics 727 (2013). [Google Scholar]
  • [8].Wu J, Traoré P, Vázquez PA, and Pérez AT, Onset of convection in a finite two-dimensional container due to unipolar injection of ions, Physical Review E 88, 053018 (2013). [DOI] [PubMed] [Google Scholar]
  • [9].Davidson SM, Andersen MB, and Mani A, Chaotic induced-charge electro-osmosis, Physical review letters 112, 128302 (2014). [DOI] [PubMed] [Google Scholar]
  • [10].Pérez A, Vázquez P, Wu J, and Traoré P, Electrohydrodynamic linear stability analysis of dielectric liquids subjected to unipolar injection in a rectangular enclosure with rigid sidewalls, Journal of Fluid Mechanics 758, 586 (2014). [Google Scholar]
  • [11].Rubinstein I and Zaltzman B, Equilibrium electroconvective instability, Physical review letters 114, 114502 (2015). [DOI] [PubMed] [Google Scholar]
  • [12].Zhang M, Martinelli F, Wu J, Schmid PJ, and Quadrio M, Modal and non-modal stability analysis of electrohydrodynamic flow with and without cross-flow, Journal of Fluid Mechanics 770, 319 (2015) [Google Scholar]
  • [13].Traoré P, Wu J, Louste C, Vazquez PA, and Perez AT, Numerical study of a plane poiseuille channel flow of a dielectric liquid subjected to unipolar injection, IEEE Transactions on Dielectrics and Electrical Insulation 22, 2779 (2015). [Google Scholar]
  • [14].Wu J and Traoré P, A finite-volume method for electro-thermoconvective phenomena in a plane layer of dielectric liquid, Numerical Heat Transfer, Part A: Applications 68, 471 (2015). [Google Scholar]
  • [15].Wu J, Perez AT, Traore P, and Vazquez PA, Complex flow patterns at the onset of annular electroconvection in a dielectric liquid subjected to an arbitrary unipolar injection, IEEE Transactions on Dielectrics and Electrical Insulation 22, 2637 (2015). [Google Scholar]
  • [16].Wu J, Traoré P, Pérez AT, and Vázquez PA, On two-dimensional finite amplitude electro-convection in a dielectric liquid induced by a strong unipolar injection, Journal of Electrostatics 74, 85 (2015). [Google Scholar]
  • [17].Zhang M, Weakly nonlinear stability analysis of subcritical electrohydrodynamic flow subject to strong unipolar injection, Journal of Fluid Mechanics 792, 328 (2016). [Google Scholar]
  • [18].Luo K, Wu J, Yi H-L, and Tan H-P, Lattice Boltzmann model for Coulomb-driven flows in dielectric liquids, Physical Review E 93, 023309 (2016). [DOI] [PubMed] [Google Scholar]
  • [19].Luo K, Wu J, Yi H-L, and Tan H-P, Three-dimensional finite amplitude electroconvection in dielectric liquids, Physics of Fluids 30, 023602 (2018). [Google Scholar]
  • [20].Luo K, Wu J, Yi H-L, Liu L-H, and Tan H-P, Hexagonal convection patterns and their evolutionary scenarios in electroconvection induced by a strong unipolar injection, Physical Review Fluids 3, 053702 (2018). [Google Scholar]
  • [21].Luo K, Li T-F, Wu J, Yi H-L, and Tan H-P, Mesoscopic simulation of electrohydrodynamic effects on laminar natural convection of a dielectric liquid in a cubic cavity, Physics of Fluids 30, 103601 (2018). [Google Scholar]
  • [22].Felici N, Phénomenes hydro et aérodynamiques dans la conduction des diélectriques fluides, Rev. Gén. Electr. 78, 717 (1969). [Google Scholar]
  • [23].Felici N and Lacroix J, Electroconvection in insulating liquids with special reference to uni-and bi-polar injection: a review of the research work at the CNRS Laboratory for Electrostatics, Grenoble 1969–1976, Journal of Electrostatics 5, 135 (1978). [Google Scholar]
  • [24].Schneider J and Watson P, Electrohydrodynamic Stability of Space-Charge-Limited Currents in Dielectric Liquids. I. Theoretical Study, The Physics of Fluids 13, 1948 (1970). [Google Scholar]
  • [25].Watson P, Schneider J, and Till H, Electrohydrodynamic Stability of Space-Charge-Limited Currents in Dielectric Liquids. II. Experimental Study, The Physics of Fluids 13, 1955 (1970). [Google Scholar]
  • [26].Atten P and Moreau R, Stabilité électrohydrodynamique des liquides isolants soumis a une injection unipolaire, J. Mécanique 11, 471 (1972). [Google Scholar]
  • [27].Lacroix J, Atten P, and Hopfinger E, Electro-convection in a dielectric liquid layer subjected to unipolar injection, Journal of Fluid Mechanics 69, 539 (1975). [Google Scholar]
  • [28].Atten P and Lacroix J, Non-linear hydrodynamic stability of liquids subjected to unipolar injection, Journal de Mécanique 18, 469 (1979). [Google Scholar]
  • [29].Atten P, Rôle de la diffusion dans le problème de la stabilité hydrodynamique d’un liquide dièlectrique soumis à une injection unipolaire forte, CR Acad. Sci. Paris 283, 29 (1976). [Google Scholar]
  • [30].Chicón R, Castellanos A, and Martin E, Numerical modelling of Coulomb-driven convection in insulating liquids, Journal of Fluid Mechanics 344, 43 (1997). [Google Scholar]
  • [31].Vazquez P, Georghiou G, and Castellanos A, Characterization of injection instabilities in electrohydrodynamics by numerical modelling: comparison of particle in cell and flux corrected transport methods for electroconvection between two plates, Journal of Physics D: Applied Physics 39, 2754 (2006). [Google Scholar]
  • [32].Ginzburg I, Verhaeghe F, and d'Humières D, Two-relaxation-time lattice Boltzmann scheme: About parametrization, velocity, pressure and mixed boundary conditions, Communications in computational physics 3, 427 (2008). [Google Scholar]
  • [33].Ginzburg I, Verhaeghe F, and d’Humieres D, Study of simple hydrodynamic solutions with the two-relaxation-times lattice Boltzmann scheme, Communications in computational physics 3,519(2008). [Google Scholar]
  • [34].d’Humieres D, Viscosity independent numerical errors for Lattice Boltzmann models: From recurrence equations to "magic" collision numbers, Comput. Math. Appl. 58, 823 (2009). [Google Scholar]
  • [35].Ginzburg I, d’Humières D, and Kuzmin A, Optimal stability of advection–diffusion lattice Boltzmann models with two relaxation times for positive/negative equilibrium, Journal of Statistical Physics 139, 1090 (2010). [Google Scholar]
  • [36].Kuzmin A, Ginzburg I, and Mohamad A, The role of the kinetic parameter in the stability of two-relaxation-time advection-diffusion lattice Boltzmann schemes, Computers & Mathematics with Applications 61, 3417 (2011). [Google Scholar]
  • [37].Ginzburg I, Truncation errors, exact and heuristic stability analysis of two-relaxation-times lattice Boltzmann schemes for anisotropic advection-diffusion equation, Communications in Computational Physics 11, 1439 (2012). [Google Scholar]
  • [38].Khirevich S, Ginzburg I, and Tallarek U, Coarse-and fine-grid numerical behavior of MRT/TRT lattice-Boltzmann schemes in regular and random sphere packings, Journal of Computational Physics 281, 708 (2015). [Google Scholar]
  • [39].Ginzburg I and Roux L, Truncation effect on Taylor–Aris dispersion in lattice Boltzmann schemes: Accuracy towards stability, Journal of Computational Physics 299, 974 (2015). [Google Scholar]
  • [40].Ginzburg I, Roux L, and Silva G, Local boundary reflections in lattice Boltzmann schemes: Spurious boundary layers and their impact on the velocity, diffusion and dispersion, Comptes Rendus Mécanique 343, 518 (2015). [Google Scholar]
  • [41].Ginzburg I, Prediction of the moments in advection-diffusion lattice Boltzmann method. II. Attenuation of the boundary layers via double-Λ bounce-back flux scheme, Physical Review E 95, 013305 (2017). [DOI] [PubMed] [Google Scholar]
  • [42].Ku HC, Hirsh RS, and Taylor TD, A pseudospectral method for solution of the three-dimensional incompressible Navier-Stokes equations, Journal of Computational Physics 70, 439 (1987). [Google Scholar]
  • [43].Fomberg B, A practical guide to pseudospectral methods (Cambridge university press,1998), Vol. 1. [Google Scholar]
  • [44].Trefethen LN, Spectral methods in MATLAB (Siam, 2000), Vol. 10. [Google Scholar]
  • [45].Boyd JP, Chebyshev and Fourier spectral methods (Courier Corporation, 2001). [Google Scholar]
  • [46].Guan Y and Novosselov I, Numerical Analysis of Electroconvection Phenomena in Cross-flow, arXiv preprint arXiv:1812.10899 (2018). [Google Scholar]
  • [47].Schmid PJ, Dynamic mode decomposition of numerical and experimental data, Journal of fluid mechanics 656, 5 (2010). [Google Scholar]
  • [48].Krüger T, Kusumaatmaja H, Kuzmin A, Shardt O, Silva G, and Viggen EM, The Lattice Boltzmann Method (Springer, 2017). [Google Scholar]
  • [49].Ginzburg I, Equilibrium-type and link-type lattice Boltzmann models for generic advection and anisotropic-dispersion equation, Advances in water resources 28, 1171 (2005). [Google Scholar]
  • [50].Hayashi K, Rojas R, Seta T, and Tomiyama A, Immersed boundary–lattice Boltzmann method using two relaxation times, The Journal of Computational Multiphase Flows 4, 193 (2012). [Google Scholar]
  • [51].Seta T, Rojas R, Hayashi K, and Tomiyama A, Implicit-correction-based immersed boundary-lattice Boltzmann method with two relaxation times, Physical Review E 89, 023307 (2014). [DOI] [PubMed] [Google Scholar]
  • [52].Yan Z, Yang X, Li S, and Hilpert M, Two-relaxation-time lattice Boltzmann method and its application to advective-diffusive-reactive transport, Advances in water resources 109, 333 (2017). [Google Scholar]
  • [53].Ginzburg I and Vikhansky A, Determination of the diffusivity, dispersion, skewness and kurtosis in heterogeneous porous flow. Part I: Analytical solutions with the extended method of moments, Advances in water resources 115, 60 (2018). [Google Scholar]
  • [54].Ginzburg I, Determination of the diffusivity, dispersion, skewness and kurtosis in heterogeneous porous flow. Part II: Lattice Boltzmann schemes with implicit interface, Advances in water resources 118, 49 (2018). [Google Scholar]
  • [55].Ginzbourg I and Adler P, Boundary flow condition analysis for the three-dimensional lattice Boltzmann model, Journal de Physique II 4, 191 (1994). [Google Scholar]
  • [56].Guan Y, Vaddi RS, Aliseda A, and Novosselov I, Experimental and Numerical Investigation of Electro-Hydrodynamic Flow in a Point-to-Ring Corona Discharge Physical Review Fluids 3, 14 (2018). [Google Scholar]
  • [57].Guan Y, Vaddi RS, Aliseda A, and Novosselov I, Analytical model of electrohydrodynamic flow in corona discharge , Physics of plasmas 25, 083507 (2018). [DOI] [PMC free article] [PubMed] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

1

RESOURCES