11const double MOLAR_GAS_CONSTANT = 8.314;
18void quadraticEquationSolver(
const std::array<REAL, 4>& A, std::vector<REAL>& X,
int* L)
23 REAL discriminant = b*b - 4*a*c;
39 else if (discriminant > 0)
42 REAL sqrt_discriminant = std::sqrt(discriminant);
43 X.push_back((-b + sqrt_discriminant) / (2*a));
44 X.push_back((-b - sqrt_discriminant) / (2*a));
47 else if (discriminant == 0)
50 X.push_back(-b / (2*a));
60int cubic(
const std::array<REAL, 4>& A, std::vector<REAL>& X,
int* L)
62 const REAL PI = 3.14159265358979323846;
63 const REAL THIRD = 1.0 / 3.0;
64 std::array<REAL, 3> U;
65 REAL W, P, Q, DIS, PHI;
70 W = A[2] / A[3] * THIRD;
71 P = std::pow(A[1] / A[3] * THIRD - std::pow(W, 2), 3);
72 Q = -.5 * (2.0 * std::pow(W, 3) - (A[1] * W - A[0]) / A[3]);
73 DIS = std::pow(Q, 2) + P;
77 PHI = std::acos(std::max(-1.0, std::min(1.0, Q / std::sqrt(-P))));
78 P = 2.0 * std::pow((-P), 0.5 * THIRD);
79 for (
int i = 0; i < 3; i++)
81 U[i] = P * std::cos((PHI + 2.0 *
static_cast<REAL
>(i) * PI) * THIRD) - W;
83 X = {U[0], U[1], U[2]};
84 std::sort(X.begin(), X.end());
91 X.push_back(cbrt(Q + DIS) + cbrt(Q - DIS) - W);
98 quadraticEquationSolver(A, X, L);
100 else if (A[1] != 0.0)
103 X.push_back(A[0] / A[1]);
113 for (
int i = 0; i < *L; i++)
115 X[i] = X[i] - (A[0] + X[i] * (A[1] + X[i] * (A[2] + X[i] * A[3]))) / (A[1] + X[i] * (2.0 * A[2] + X[i] * 3.0 * A[3]));
121void ComputeFugacity(
Components& TempComponents,
double Pressure,
double Temperature)
123 printf(
"================FUGACITY COEFFICIENT CALCULATION================\n");
124 double SumofFractions = 0.0;
125 std::vector<double> MolFraction, PartialPressure, LocalPc, LocalTc, LocalAc, CompNum;
126 std::vector<double> a, b, A, B;
130 int FrameworkComponents = TempComponents.NComponents.y;
132 bool NeedEOSFugacityCoeff =
false;
133 for(
size_t comp = FrameworkComponents; comp < TempComponents.Total_Components; comp++)
135 printf(
"Checking: Current Fugacity Coeff for %zu component: %.5f\n", comp, TempComponents.FugacityCoeff[comp]);
136 if(TempComponents.FugacityCoeff[comp] < 0.0)
138 printf(
"Component %zu needs PR-EOS for fugacity coeff (negative value), going to ignore the fugacity coefficient for other components and calculate all using PR-EOS!", comp);
139 NeedEOSFugacityCoeff =
true;
143 if(!NeedEOSFugacityCoeff){ printf(
"Every Adsorbate Component has fugacity coefficient assigned, skip EOS calculation!\n");
return;}
144 printf(
"start calculating fugacity, Pressure: %.5f, Temperature: %.5f\n", Pressure, Temperature);
146 for(
size_t comp = FrameworkComponents; comp < TempComponents.Total_Components; comp++)
148 double ComponentMolFrac = TempComponents.MolFraction[comp];
149 SumofFractions += ComponentMolFrac;
150 MolFraction.push_back(ComponentMolFrac);
152 double CurrPartialPressure = ComponentMolFrac * Pressure;
153 PartialPressure.push_back(CurrPartialPressure);
155 double ComponentPc = TempComponents.Pc[comp];
156 double ComponentTc = TempComponents.Tc[comp];
157 double ComponentAc = TempComponents.Accentric[comp];
159 LocalPc.push_back(ComponentPc);
160 LocalTc.push_back(ComponentTc);
161 LocalAc.push_back(ComponentAc);
164 double Tr = Temperature / ComponentTc;
165 double kappa = 0.37464 + 1.54226 * ComponentAc - 0.26992 * std::pow(ComponentAc, 2);
166 double alpha = std::pow(1.0 + kappa * (1.0 - std::sqrt(Tr)), 2);
167 a.push_back(0.45724 * alpha * std::pow(MOLAR_GAS_CONSTANT * ComponentTc, 2) / ComponentPc);
168 b.push_back(0.07780 * MOLAR_GAS_CONSTANT * ComponentTc / ComponentPc);
169 A.push_back(a.back() * Pressure / std::pow(MOLAR_GAS_CONSTANT * Temperature, 2));
170 B.push_back(b.back() * Pressure / (MOLAR_GAS_CONSTANT * Temperature));
172 CompNum.push_back(comp);
174 printf(
"Component %zu, Pc: %.5f, Tc: %.5f, Ac: %.5f\n", comp, ComponentPc, ComponentTc, ComponentAc);
175 printf(
"Component Mol Fraction: %.5f\n", SumofFractions);
176 printf(
"kappa: %.5f, alpha: %.5f\n", kappa, alpha);
181 if(std::abs(SumofFractions - 1.0) > 0.0001)
183 throw std::runtime_error(
"Sum of Mol Fractions does not equal 1.0");
188 for(
int num : CompNum)
190 std::cout << num << std::endl;
193 size_t NumberOfComponents = CompNum.size();
195 std::vector<std::vector<double>> BinaryInteractionParameter(NumberOfComponents, std::vector<double>(NumberOfComponents, 0.0));
196 std::vector<std::vector<double>> aij(NumberOfComponents, std::vector<double>(NumberOfComponents));
197 std::vector<std::vector<double>> Aij(NumberOfComponents, std::vector<double>(NumberOfComponents));
199 for(
size_t i = 0; i < NumberOfComponents; i++)
201 for(
size_t j = 0; j < NumberOfComponents; j++)
203 aij[i][j] = (1.0 - BinaryInteractionParameter[i][j]) * std::sqrt(a[i] * a[j]);
204 Aij[i][j] = (1.0 - BinaryInteractionParameter[i][j]) * std::sqrt(A[i] * A[j]);
211 for(
size_t i = 0; i < NumberOfComponents; i++)
213 Bmix += MolFraction[i] * b[i];
214 for(
size_t j = 0; j < NumberOfComponents; j++)
216 Amix += MolFraction[i] * MolFraction[j] * aij[i][j];
220 Amix *= Pressure / std::pow(MOLAR_GAS_CONSTANT * Temperature, 2);
221 Bmix *= Pressure / (MOLAR_GAS_CONSTANT * Temperature);
223 double Coefficients[4];
224 Coefficients[3] = 1.0;
225 Coefficients[2] = Bmix - 1.0;
226 Coefficients[1] = Amix - 3.0 * std::pow(Bmix, 2) - 2.0 * Bmix;
227 Coefficients[0] = -(Amix * Bmix - std::pow(Bmix, 2) - std::pow(Bmix, 3));
228 std::array<REAL, 4> CoefficientsArray = {Coefficients[0], Coefficients[1], Coefficients[2], Coefficients[3]};
232 std::vector<double> Compressibility;
233 int NumberOfSolutions = 0;
234 cubic(CoefficientsArray,Compressibility,&NumberOfSolutions);
237 printf(
"Number of Solutions: %d\n", NumberOfSolutions);
241 if(Compressibility.size() > 0)
243 if (Compressibility[0]<Compressibility[1])
245 temp=Compressibility[0];
246 Compressibility[0]=Compressibility[1];
247 Compressibility[1]=temp;
249 if(Compressibility.size() > 1)
250 if (Compressibility[1]<Compressibility[2])
252 temp=Compressibility[1];
253 Compressibility[1]=Compressibility[2];
254 Compressibility[2]=temp;
256 if(Compressibility[0]<Compressibility[1])
258 temp=Compressibility[0];
259 Compressibility[0]=Compressibility[1];
260 Compressibility[1]=temp;
267 std::vector<std::vector<double>> FugacityCoefficients(NumberOfComponents, std::vector<double>(NumberOfSolutions, 0.0));
269 for(
size_t i = 0; i < NumberOfComponents; i++)
271 for(
size_t j = 0; j < NumberOfSolutions; j++)
274 for(
size_t k = 0; k < NumberOfComponents; k++)
276 sumAij += 2.0 * MolFraction[k] * Aij[i][k];
280 FugacityCoefficients[i][j] = exp((B[i] / Bmix) * (Compressibility[j] - 1.0) - log(Compressibility[j] - Bmix)
281 - (Amix / (2.0 * sqrt(2.0) * Bmix)) * (sumAij / Amix - B[i] / Bmix) *
282 log((Compressibility[j] + (1.0 + sqrt(2.0)) * Bmix) / (Compressibility[j] + (1.0 - sqrt(2.0)) * Bmix)));
289 for(
size_t i = 0; i < NumberOfComponents; i++)
291 int index = FrameworkComponents + i;
292 if(NumberOfSolutions == 1)
295 TempComponents.FugacityCoeff[index]= FugacityCoefficients[i][0];
302 if(Compressibility[2] > 0.0)
305 if(FugacityCoefficients[i][0] < FugacityCoefficients[i][2])
307 TempComponents.FugacityCoeff[index] = FugacityCoefficients[i][0];
309 else if(FugacityCoefficients[i][0] > FugacityCoefficients[i][2])
312 TempComponents.FugacityCoeff[index] = FugacityCoefficients[i][2];
317 TempComponents.FugacityCoeff[index] = FugacityCoefficients[i][0];
323 TempComponents.FugacityCoeff[index] = FugacityCoefficients[i][0];
326 printf(
"Fugacity Coefficient for component %zu is %.10f\n", index, TempComponents.FugacityCoeff[index]);
327 for(
size_t ii = 0; ii < FugacityCoefficients.size(); ii++)
328 for(
size_t jj = 0; jj < FugacityCoefficients[ii].size(); jj++)
329 printf(
"Check: Computed FugaCoeff for %zu, %zu is %.10f\n", ii, jj, FugacityCoefficients[ii][jj]);
331 printf(
"================END OF FUGACITY COEFFICIENT CALCULATION================\n");
Definition data_struct.h:843