Bipolar Electrodialysis (1D)
from watertap.unit_models.electrodialysis_bipolar_1D import Electrodialysis_Bipolar_1D
Introduction
Bipolar electrodialysis, an electrochemical separation technology, is primarily used to generate acids and bases from concentrated salt solution [1]. Recently, multiple proof of concept studies have shown that, starting from Lithium Chloride solution, bipolar membranes can produce Lithium Hydroxide [2] [3]. Environmentally hazardous concentrated brine, produced at the end of water purification, can be converted to valuable sodium hydroxide via bipolar membrane electrodialysis, thus creating a new revenue stream [4]. The bipolar membrane (BPM) typically is made of an Anion exhcange layer and Cation exchange layer sandwiched together, usually with catalyst added to improve the hydrolysis reaction. To produce products from salts, the BPM is placed in parallel with a cation exchange membrane (CEM) and an anion exchange membrane (AEM). To obtain a model for bipolar electrodialysis, we create a model from existing literature. The unit model uses the reduced order model for water disassociation proposed by Mareev et al. (2020) [5]. While their work primarily focuses on simulating potential profile within the bipolar membrane, they also find reasonably good agreements with the voltage-current experiments performed by Wilhelm et al. (2002) [6]. Hence, the Mareev et al. (2020) [5] framework for hydrolysis flux that incorporates catalyst action is used. Water splitting occurs only when the limiting current on the BPM is exceeded. An expression for the limiting current is obtained from existing literature [7] [13]. These two components are coupled using the best available model for current density [7] [13]. Combining the BPM with the AEM and CEM, this unit model can be deployed to model acid and base production from concentrated salt solutions. The mass transfer is modelled using rigorously validated conventional electrodialysis equations. Hence, high fidelity prediction of bipolar electrodialysis process will be possible with this unit model. A sketch of the bipolar membrane cell stack is shown in Figure 1 with the diluate, basic, and acidic channels that produce low concentration brine, base, and acid, respectively. Users may choose to add ions via the feed. More overview of the bipolar electrodialysis technology can be found in the References.

Figure 1. Schematic representation of a bipolar electrodialysis unit
One set of BPM, CEM, AEM, along with the diluate, basic, and acidic channels can thus be treated as a modelling unit that can multiply to larger-scale systems. The presented bipolar electrodialysis model establishes mathematical descriptions of ion and water transport across the membrane along with water disassociation. Modelled transfer mechanisms include electrical migration, diffusion of ions, osmosis, electroosmosis, and water splitting. The following are the key assumptions made:
The diluate, basic, and acidic channels have identical geometry.
For each channel, component fluxes in the bulk solution has variation along the vertical direction (l), as depicted in in Figure 1, but uniform in the other two orthogonal directions, b (cell width) and d, (the 1-dimensional assumption).
Steady state: all variables are independent of time.
Co-current flow operation.
Ideality assumptions: activity, osmotic, and van’t Hoff coefficients are set at one.
Ion transport number, water transport number, and permeability are constant over space.
Detailed concentration gradient effect at membrane-water interfaces is neglected.
Constant pressure and temperature through each channel.
No boundary layer, electric double layer, or diffusion layer next to the monopolar membranes has been considered. For typical operating conditions of a bipolar membrane system, such low salinity in the diluate is not expected.
All instances of limiting current density, unless explicitly specified, refer to salt ion limiting current density across BPM.
The hydrolysis limiting current on BPM is expected to be much higher and does not have a suitable model in literature. Hence, it is not included in the unit model.
Control Volumes
This model has three control volumes for the acidic and basic channels.
diluate channel
acidic channel
basic channel
Ports
On the two control volumes, this model provides six ports (Pyomo notation in parenthesis):
inlet_diluate (inlet)
outlet_diluate (outlet)
inlet_acidic (inlet)
outlet_acidic (outlet)
inlet_basic (inlet)
outlet_basic (outlet)
Sets
This model can simulate the water splitting and the transport of multiple species. All solution components ( H2O, neutral solutes, and ions, including Proton and Hydroxide ions) form a Pyomo set in the model. For a clear model demonstration, this document uses an aqueous NaCl solution along with the products of water splitting, H+ and OH-, hereafter.
This model can mathematically take a multi-component solution (i.e., one salt molecule to be treated) as an input; nevertheless, a multi-component solution introduces parameters that are either unknown or difficult to estimate (e.g., electrical transport numbers through membranes, multi-ion diffusivity, etc.) and physical relationships that may result in ill-posed or ill-conditioned problems, translating to numerical challenges that can make models difficult to solve.’ While we continuously work on advancing our models to incorporate new principles revealed by new research findings, we advise users to be cautious when simulating multi-component systems with the current model, due to the aspects stated above. This unit model works with the MCAS property model.
Description |
Symbol |
Indices |
---|---|---|
Time |
\(t\) |
[t]1 |
Length domain |
\(x\) |
\(l \times(0, 1)\) 2 |
Phase |
\(p\) |
[‘Liq’] |
Component |
\(j\) |
[‘H2 O’, ‘Na+’, ‘Cl-’, ‘H+’, ‘OH-‘] |
Ion |
\(j\) |
[‘Na+’, ‘Cl-’, ‘H+’, ‘OH-’] 3 |
Membrane |
n/a |
[‘AEM’,’CEM’,’BPM’] |
- Notes
1 The time set index is set as [0] in this steady-state model and is reserved majorly for the future extension to a dynamic model.
2 By the IDAES convention, the index of length domain is normalized to a continuous set of (0, 1), which is discretized when differential equations in the model are solved by numerical methods such as “finite difference” discretization. In this documentation, \(x\) refers to the length dimension before normalization and carries a unit of [m].
3 “Ion” is a subset of “Component” and uses the same symbol j.
4 Please note that Na +, Cl - H+ and OH- information must be supplied. Otherwise an error will be thrown.
5 Additional ions can be added by the user and will not throw errors. However, areal resistance calculation assumes NaOH and HCl in the acid and base concentration. Hence, calculations will not be accurate unless users manually correct for areal resistance computation.
Degrees of Freedom
The bipolar membrane model has multiple degrees of freedom, among which temperature, pressure, and component molar flow rate are state variables that are fixed as initial conditions. The rest are parameters that should be provided in order to fully solve the model. The exact degrees of freedom depend on the mode of operation. For the simplest case where no water splitting occurs and the bipolar membrane acts like a simple electrodialysis membrane,these degrees of freedom are:
Description |
Symbol |
Variable Name |
Index |
Units |
DOF Number 1 |
---|---|---|---|---|---|
Temperature, inlet_diluate |
\(T^{diluate}\) |
temperature |
None |
\(K\) |
1 |
Temperature, inlet_acidic |
\(T^{acidic}\) |
temperature |
None |
\(K\) |
1 |
Temperature, inlet_basic |
\(T^{basic}\) |
temperature |
None |
\(K\) |
1 |
Pressure, inlet_diluate |
\(p^{diluate}\) |
temperature |
None |
\(Pa\) |
1 |
Pressure, inlet_acidic |
\(p^{acidic}\) |
temperature |
None |
\(Pa\) |
1 |
Pressure, inlet_basic |
\(p^{basic}\) |
temperature |
None |
\(Pa\) |
1 |
Component molar flow rate, inlet_diluate |
\(N_{j,in}^{diluate}\) |
flow_mol_phase_comp |
[t], [‘Liq’], [‘H2O’, ‘Na+’, ‘Cl-’, ‘H+’, ‘OH-‘] |
\(mol \, s^{-1}\) |
5 |
Component molar flow rate, inlet_acidic |
\(N_{j,in}^{acidic}\) |
flow_mol_phase_comp |
[t], [‘Liq’], [‘H2O’, ‘Na+’, ‘Cl-’, ‘H+’, ‘OH-‘] |
\(mol \, s^{-1}\) |
5 |
Component molar flow rate, inlet_basic |
\(N_{j, in}^{basic}\) |
flow_mol_phase_comp |
[t], [‘Liq’], [‘H2O’, ‘Na+’, ‘Cl-’, ‘H+’, ‘OH-‘] |
\(mol \, s^{-1}\) |
5 |
Water transport number |
\(t_w\) |
water_trans_number_membrane |
[‘AEM’,’CEM’,’BPM’] |
dimensionless |
3 |
Water permeability |
\(L\) |
water_permeability_membrane |
[‘AEM’,’CEM’,’BPM’] |
\(m^{-1}s^{-1}Pa^{-1}\) |
3 |
Voltage or Current 2 |
\(U\) or \(I\) |
voltage or current |
[t] |
\(\text{V}\) or \(A\) |
1 |
Electrode areal resistance |
\(r_{el}\) |
electrodes_resistance |
None |
\(\Omega \,m^2\) |
1 |
Cell number |
\(n\) |
cell_triplet_num |
None |
dimensionless |
1 |
Current utilization coefficient |
\(\xi\) |
current_utilization |
None |
dimensionless |
1 |
Shadow factor |
\(\beta\) |
shadow_factor |
None |
dimensionless |
1 |
Spacer thickness |
\(s\) |
spacer_thickness |
None |
\(m\) |
1 |
Cell width |
\(b\) |
cell_width |
None |
\(\text{m}\) |
1 |
Cell length |
\(l\) |
cell_length |
None |
\(\text{m}\) |
1 |
Channel height |
\(d\) |
channel_height |
None |
\(m\) |
1 |
Thickness of ion exchange membranes |
\(\delta\) |
membrane_thickness |
[‘AEM’,’CEM’,’BPM’] |
\(m\) |
3 |
Transport number of ions in the membrane phase |
\(t_j\) |
ion_trans_number_membrane |
[‘AEM’,’CEM’,’BPM’], [‘Na+’, ‘Cl-’, ‘H+’, ‘OH-‘] |
dimensionless |
9 |
Diffusivity of solute in the membrane phase |
\(D\) |
solute_diffusivity_membrane |
[‘AEM’,’CEM’,’BPM’], [‘Na+’, ‘Cl-’, ‘H+’, ‘OH-‘] |
dimensionless |
9 |
Constant areal resistance of membrane at infinity-approximated electrolyte concentration |
\(r_0\) |
membrane_areal_resistance_coef_0 |
None |
\(\Omega \, m^2\) |
1 |
Coefficient of membrane areal resistance to 1/c, where c is the electrolyte concentration |
\(r_1\) |
membrane_areal_resistance_coef_1 |
None |
\(\Omega \, Kg\,m^{-1}\) |
1 |
Salt diffusivity |
\(D^*\) |
diffus_mass |
None |
\(m^2\, s^{-1}\) |
1 |
Salt concentration, basic side 3 |
\(C_{basic}\) |
salt_conc_ael_ref |
None |
\(mol\, m^{-3}\) |
1 |
Salt concentration, acidic side 3 |
\(C_{acidic}\) |
salt_conc_cel_ref |
None |
\(mol \,m^{-3}\) |
1 |
Membrane Fixed charge |
\(\sigma\) |
membrane_fixed_charge |
None |
\(mol \,m^{-3}\) |
1 |
Dissociation rate constant, zero electric field |
\(k_2(0)\) |
k2_zero |
None |
\(s^{-1}\) |
1 |
Concentration of water |
\(C_{H_2O}\) |
conc_water |
None |
\(mol\, m^{-3}\) |
1 |
Relative permittivity |
\(\epsilon_r\) |
relative_permittivity |
None |
Non-dimensional |
1 |
Catalyst concentration on the cation exchange side |
\(Q_{m,A}\) |
membrane_fixed_catalyst_cel |
None |
\(mol \, m^{-3}\) |
1 |
Catalyst concentration on the anion exchange side |
\(Q_{m,B}\) |
membrane_fixed_catalyst_ael |
None |
\(mol \, m^{-3}\) |
1 |
Equilibrium constant of proton disassociation |
\(K_A\) |
k_a |
None |
\(mol \, m^{-3}\) |
1 |
Equilibrium constant of hydroxide disassociation |
\(K_B\) |
k_b |
None |
\(mol \, m^{-3}\) |
1 |
- Note
1 DOF number takes account of the indices of the corresponding parameter.
2 A user should provide either current or voltage as the electrical input, in correspondence to the “Constant_Current” or “Constant_Voltage” treatment mode (configured in this model). The user also should provide an electrical magnitude that ensures an operational current above the bipolar membrane limiting current.
3 ‘salt_conc_ael_ref’ and ‘salt_conc_ael_ref’ need to be specified only when
salt_calculation=False
is chosen. Whensalt_calculation=True
\(C_{basic}\) and \(C_{acidic}\) salt_conc_ael_x and salt_conc_cel_x are computed with indexes [t,x] and do not need to be specified.
Solution component information
To fully construct solution properties, users need to provide basic component information of the feed solution to use this model. Below is a sample:
ion_dict = {
"solute_list": ["Na_+", "Cl_-", "H_+", "OH_-"],
"mw_data": {
"Na_+": 23e-3,
"Cl_-": 35.5e-3,
"H_+": 1e-3,
"OH_-": 17.0e-3,
},
"elec_mobility_data": {
("Liq", "Na_+"): 5.19e-8,
("Liq", "Cl_-"): 7.92e-8,
("Liq", "H_+"): 36.23e-8,
("Liq", "OH_-"): 20.64e-8,
},
"charge": {"Na_+": 1, "Cl_-": -1, "H_+": 1, "OH_-": -1},
"diffusivity_data": {
("Liq", "Na_+"): 1.33e-9,
("Liq", "Cl_-"): 2.03e-9,
("Liq", "H_+"): 9.31e-9,
("Liq", "OH_-"): 5.27e-9,
},
}
This model, by default, uses H2O as the solvent of the feed solution. Please note that Na +, Cl - H+ and OH- information must be supplied. Otherwise an error will be thrown.
Information regarding the property package this unit model relies on can be found in the MCAS module.
Equations
This model solves mass balances of all solution components (H2O, Na +, Cl - H+ and OH- ) on three control volumes (acidic, basic, and diluate channels). Under the 1D treatment, balance equations are expressed as differential algebraic equations (DAE) when concerned variables are functions of length (x). The DAEs are solved in a discretization manner using the “finite difference” or “collocation” method implemented in Pyomo.DAE.
To create a model for bipolar electrodialysis, we use the mass transfer equations from conventional electrodialysis on the CEM and AEM (for further details please refer to Electrodialysis 1D) and couple it with equations developed for BPM.
Across the BPM, water disassociation occurs when the limiting current is exceeded. Assuming the unit model is operated in the hydrolysis regime, the current density consists of the limiting current and the water splitting current. See equation (3) in Wilhelm et al. (2001) [7] or equations (11) and (12) from González et al. (2023) [13] for further details. The limiting current density is obtained from González et al. (2023) [13]. It sets the amount of salt ions flowing across the BPM. The governing equations for catalyst induced water disassociation is derived from the model proposed by Mareev et al. (2020) [5]. The equations pertaining to the BPM are given below.
Description |
Equation |
Configuration |
---|---|---|
Limiting current density |
\(i_{lim}(x) =\) user input constant |
|
\(i_{lim} (x) = D^*F (C_{acidic,NaCl}(x)+C_{basic,NaCl}(x))^2 / (\sigma \delta)\) |
|
|
Water splitting flux 3 |
\(S_{diss}(x) =R_{K_A} \lambda(x) + R_{K_B} \lambda(x)\) |
|
Water splitting rate 4 |
\(R_{K_A}(x) = \frac{Q_{m,A}}{K_{A}}[k_2(0)f[E(x)]C_{H_2O} ]\) |
|
\(R_{K_B}(x) = \frac{Q_{m,B}}{K_{B}}[k_2(0)f[E(x)]C_{H_2O} ]\) |
||
Depletion length 5 |
\(\lambda(x) = E(x) \epsilon_0 \epsilon_r / (F \sigma)\) |
|
Hydrolysis voltage drop |
\(u_{diss}(x) = E(x) \lambda(x)\) |
|
Electric current density 6 |
\(i(x) = i_{lim}(x) + F S_{diss}(x)\) |
|
Potential drop |
\(U(x)=n E(x)/\lambda(x) + i(x) r_{tot}(x)\) |
- Note
1 The diffusivity \(D^*\) used here for the salt and should not be confused with the ion diffusivity.
2 The limiting current density is set by balance of electrical migration and diffusion and obtained from equation (15) in González et al. (2023) [13].
3 Water disassociation flux is obtained from equation (35) in Mareev et al. (2020) [5].
4 Hydrolysis rate with catalyst present is obtained from equation (16) in Mareev et al. (2020) after neglecting the recombination, in line with the approximation made later in their derivation [5].
5 The relationship between the electric field at the junction of the bipolar membrane’s charged layers \(E\) to the depletion layer has been derived from equations (26-27) in Melnikov (2022) [8].
6 Total current density has been obtained from equation (3) in Wilhelm et al. (2001) [7]. Alternatively, please refer to equations (11) and (12) from González et al. (2023) [13].
Please note that the unit model is assumed to operate in the water splitting regime. Hence, \(i_{lim}\) is always computed since hydrolysis current is the portion that is in excess of the limiting current. Below the water splitting regime, the bipolar membrane behaves like a conventional ion exchange membrane, albeit with much lower mass transfer. Most cases do not operate in this regime [2] [3] [4]. Hence, the sub-limiting case has not been implemented in this unit model. \(f[E]\) is the second Wien effect driven enhancement of the dissociation rate under applied electric field. It requires input temperature and relative permittivity (\(\epsilon_r\)), and the full expression has been obtained from Mareev et al. (2020) [5]. While water is consumed during hydrolysis, there is an also transport across the membrane. For this component, we use the equations from conventional electrodialysis.
The fluxes on each membrane is collected and presented here. The positive direction for the mass fluxes \(J\) is from cathode to anode. The water dissociation fluxes, \(S\), flow out from the central depletion region of the bipolar membrane while water is drawn in. Here, the convention is that the outflow from the bipolar membrane is in the positive direction.
Flux Equations
Description |
Equation |
Index set |
---|---|---|
Mass transfer flux, BPM, ions |
\(J^{BPM}_j(x) = t_j^{BPM}\frac{\xi i_{lim}(x)}{ z_j F}\) |
\(j \in \left['{Na^+} ', '{Cl^-}', '{H^+} ', '{OH^-} '\right]\) |
Mass transfer flux, BPM, H2O |
\(J^{BPM}_j(x) = t_w^{BPM} \left(\frac{i(x)}{F}\right)+\left(L^{BPM} \right)\left(p_{osm}^{acidic}(x)-p_{osm}^{basic}(x) \right)\left(\frac{\rho_w}{M_w}\right)\) |
\(j \in \left['H_2 O'\right]\) |
Water disassociation flux, BPM, ions |
\(S^{BPM}_j (x)= S_{diss}(x)\) |
\(j \in \left['{H^+}, {OH^-} '\right]\) |
\(S^{BPM}_j (x)= 0\) |
\(j \in \left['{Na^+} ', '{Cl^-}'\right]\) |
|
Water disassociation flux, BPM, H2O |
\(S^{BPM}_j(x) = -0.5 S_{diss}(x)\) |
\(j \in \left['H_2 O'\right]\) |
Mass transfer flux, CEM, ions |
\(J^{AEM}_j(x) = \left(t_j^{AEM} \right)\frac{\xi i(x)}{ z_j F}-\frac{D_j^{AEM}}{\delta ^{AEM} }\left(c_j^{acidic}(x)-c_j^{diluate}(x) \right)\) |
\(j \in \left['{Na^+} ', '{Cl^-}', '{H^+} ', '{OH^-} '\right]\) |
Mass transfer flux, AEM, H2O |
\(J^{AEM}_j(x) = t_w^{AEM} \left(\frac{i(x)}{F}\right)+\left(L^{AEM} \right)\left(p_{osm}^{acidic}(x)-p_{osm}^{diluate}(x) \right)\left(\frac{\rho_w}{M_w}\right)\) |
\(j \in \left['H_2 O'\right]\) |
Mass transfer flux, CEM, ions |
\(J^{CEM}_j(x) = \left(t_j^{CEM} \right)\frac{\xi i(x)}{ z_j F}-\frac{D_j^{CEM}}{\delta ^{CEM} }\left(c_j^{basic}(x)-c_j^{diluate}(x) \right)\) |
\(j \in \left['{Na^+} ', '{Cl^-}', '{H^+} ', '{OH^-} '\right]\) |
Mass transfer flux, CEM, H2O |
\(J^{CEM}_j(x) = t_w^{CEM} \left(\frac{i(x)}{F}\right)+\left(L^{CEM} \right)\left(p_{osm}^{basic}(x)-p_{osm}^{diluate}(x) \right)\left(\frac{\rho_w}{M_w}\right)\) |
\(j \in \left['H_2 O'\right]\) |
Appropriately combining the various fluxes and assigning them to the channels the results are given here.
Mass Balance Equations
Description |
Equation |
Index set |
---|---|---|
Mass balance basic channel |
\(\left(\frac{\partial N_j (x)}{\partial x}\right)^{\bf{basic}}+(-J_j(x)^{BPM} + J_j(x)^{CEM} + S_j(x)^{BPM} ) b=0\) |
\(j \in \left['H_2 O', '{Na^+} ', '{Cl^-}', '{H^+} ', '{OH^-} '\right]\) |
Mass balance acidic channel |
\(\left(\frac{\partial N_j (x)}{\partial x}\right)^{\bf{acidic}}+(J_j(x)^{BPM} + J_j(x)^{AEM} + S_j(x)^{BPM} ) b=0\) |
\(j \in \left['H_2 O', '{Na^+} ', '{Cl^-}', '{H^+} ', '{OH^-} '\right]\) |
Mass balance diluate channel |
\(\left(\frac{\partial N_j (x)}{\partial x}\right)^{\bf{diluate}}-(J_j(x)^{AEM} + J_j(x)^{CEM}) b=0\) |
\(j \in \left['H_2 O', '{Na^+} ', '{Cl^-}', '{H^+} ', '{OH^-} '\right]\) |
The flux and potential drop on the bipolar membrane are tested against the experimental data available from Wilhelm et al. (2002), [6] and we find reasonably good agreement. Some key inputs for the validation were obtained from Mareev et al. (2020) [5]. \(K_A\) is not readily available, so it is determined by best fit. The mass transfer flux employs the well tested conventional electrodialysis framework. Hence, robust predictions of bipolar electrodialysis operation is expected. Some of the key operational and performance metrics are reported below.
Electrical and Performance Equations
Description |
Equation |
---|---|
Electrical input condition |
\(i(x) = \frac{I}{bl}\), for ‘Constant_Current’; \(u(x) =U\) for ‘Constant_Voltage’ |
Potential drop |
\(u(x) = n u_{diss}(x) + i(x) r_{tot}(x)\) |
Resistance calculation |
\(r_{tot}(x)=n\left(r_0 + r_1/(C'_{acidic,HCl}(x)+C'_{basic,NaOH}(x))\right)+r_{el}\) |
Electrical power consumption |
\(P(x)=b\int _0 ^l u(x)i(x) dx\) |
- Note
1 The areal resistance functional form is based on Galama et al. (2014) [9].
2 \(C'\) is expressed in \(kg/m^3\).
3 Areal resistance calculation assume NaOH and HCl in the acid and base channels. Additional ions can be added by the user and will not throw errors. However, calculations will not be accurate unless users manually account for areal resistance computation.
All equations are coded as “constraints” (Pyomo). Isothermal and isobaric conditions apply.
The model has been validated against the experimental data available from Wilhelm et al. (2002) [6],bipolar membrane information available online: Fumatech, Technical Data Sheet for Fumasep FBM, 2020 [10] (additional inputs were obtained from from Ionescu, Viorel (2023) [11]) and bench scale experimental data provided by the New Mexico State University team.
Frictional pressure drop
This model can optionally calculate pressured drops along the flow path in the diluate and concentrate channels through
config has_pressure_change
and pressure_drop_method
. Under the assumption of identical diluate and concentrate
channels and starting flow rates, the flow velocities in the two channels are approximated equal and invariant over the
channel length when calculating the frictional pressure drops. This approximation is based on the evaluation that the
actual velocity variation over the channel length caused by water mass transfer across the consecutive channels leads to
negligible errors, as compared to the uncertainties carried by the frictional pressure method itself. The
essential equations to simulate the pressure drop are provided here. Among extensive literatures using these equations, a good reference
paper is by Wright et. al., 2018 [12].
Essential Pressure Drop Equations
Description |
Equation |
Condition |
---|---|---|
Frictional pressure drop, Darcy_Weisbach |
\(p_L=f\frac{\rho v^2}{2d_H}\) 1 |
has_pressure_change == True and pressure_drop_method == PressureDropMethod.Darcy_Weisbach |
\(p_L=\) user-input constant |
has_pressure_change == True and pressure_drop_method == PressureDropMethod.Experimental |
|
Hydraulic diameter |
\(d_H=\frac{2db(1-\epsilon)}{d+b}\) |
hydraulic_diameter_method == HydraulicDiameterMethod.conventional |
\(d_H=\frac{4\epsilon}{\frac{2}{h}+(1-\epsilon)S_{v,sp}}\) |
hydraulic_diameter_method == HydraulicDiameterMethod.spacer_specific_area_known |
|
Reynold number |
\(Re=\frac{\rho v d_H}{\mu}\) |
has_pressure_change == True or limiting_current_density_method == LimitingCurrentDensityMethod.Theoretical |
Schmidt number |
\(Sc=\frac{\mu}{\rho D_b}\) |
has_pressure_change == True or limiting_current_density_method == LimitingCurrentDensityMethod.Theoretical |
Sherwood number |
\(Sh=0.29Re^{0.5}Sc^{0.33}\) |
has_pressure_change == True or limiting_current_density_method == LimitingCurrentDensityMethod.Theoretical |
Darcy’s frictional factor |
\(f=4\times 50.6\epsilon^{-7.06}Re^{-1}\) |
friction_factor_method == FrictionFactorMethod.Gurreri |
\(f=4\times 9.6 \epsilon^{-1} Re^{-0.5}\) |
friction_factor_method == FrictionFactorMethod.Kuroda |
|
Pressure balance |
\(p_{in}-p_L l =p_{out}\) |
has_pressure_change == True |
Note
1 As discussed in the last paragraph, in this section we assumed a constant linear velocity (in the cell length direction), \(v\), in both channels and along the flow path. This \(v\) is calculated from the volume flow rate at \(x=0\) by the property package.
Nomenclature
Symbol |
Description |
Unit |
---|---|---|
Parameters |
||
\(\rho_w\) |
Mass density of water |
\(kg\ m^{-3}\) |
\(M_w\) |
Molecular weight of water |
\(kg\ mol^{-1}\) |
Variables |
||
\(N\) |
Molar flow rate of a component |
\(mol\ s^{-1}\) |
\(J\) |
Molar flux of a component |
\(mol\ m^{-2}s^{-1}\) |
\(b\) |
Cell/membrane width |
\(m\) |
\(l\) |
Cell/membrane length |
\(m\) |
\(t\) |
Ion transport number |
dimensionless |
\(I\) |
Current input |
\(A\) |
\(i\) |
Current density |
\(A m^{-2}\) |
\(U\) |
Voltage input over a stack |
\(V\) |
\(u\) |
x-dependent voltage over a stack |
\(V\) |
\(n\) |
Cell number |
dimensionless |
\(\xi\) |
Current utilization coefficient (including ion diffusion and water electroosmosis) |
dimensionless |
\(\beta\) |
Shadow factor |
dimensionless |
\(z\) |
Ion charge |
dimensionless |
\(F\) |
Faraday constant |
\(C\ mol^{-1}\) |
\(\epsilon_0\) |
permittivity of free space |
\(C\ mol^{-1}\) |
\(D\) |
Ion Diffusivity |
\(F m^-1\) |
\(\delta\) |
Membrane thickness |
\(m\) |
\(c\) |
Solute concentration |
\(mol\ m^{-3}\) |
\(t_w\) |
Water electroosmotic transport number |
dimensionless |
\(L\) |
Water permeability (osmosis) |
\(ms^{-1}Pa^{-1}\) |
\(p_{osm}\) |
Osmotic pressure |
\(Pa\) |
\(r_{tot}\) |
Total areal resistance |
\(\Omega\, m^2\) |
\(r\) |
Membrane areal resistance |
\(\Omega m^2\) |
\(r_{el}\) |
Electrode areal resistance |
\(\Omega m^2\) |
\(d\) |
Spacer thickness |
\(m\) |
\(P\) |
Power consumption |
\(W\) |
\(Q\) |
Volume flow rate |
\(m^3s^{-1}\) |
\(\phi_d^{ohm}\) |
Ohmic potential across a Nernst diffusion layer |
\(V\) |
Subscripts and superscripts |
||
\(j\) |
Component index |
|
\(in\) |
Inlet |
|
\(out\) |
Outlet |
|
\(acidic\) |
Acid channel |
|
\(basic\) |
Base channel |
|
\(diluate\) |
Salt channel |
|
\(AEM\) |
Anion exchange membrane |
|
\(CEM\) |
Cation exchange membrane |
|
\(BPM\) |
Bipolar membrane |
Class Documentation
watertap.unit_models.Bipolar_Electrodialysis_0D