Skip to content

Commit 099a0d9

Browse files
authored
Whitespace style (#955)
* style: whitespace and comment fixes
1 parent e38f402 commit 099a0d9

File tree

123 files changed

+1901
-2010
lines changed

Some content is hidden

Large Commits have some content hidden by default. Use the searchbox below for content that may be hidden.

123 files changed

+1901
-2010
lines changed

src/main/java/neqsim/PVTsimulation/simulation/SaturationPressure.java

+1-1
Original file line numberDiff line numberDiff line change
@@ -117,7 +117,7 @@ public static void main(String[] args) {
117117
// satPresSim.getThermoSystem().display();
118118
/*
119119
* double saturationPressure = 350.0; double saturationTemperature = 273.15 + 80;
120-
*
120+
*
121121
* TuningInterface tuning = new TuneToSaturation(satPresSim);
122122
* tuning.setSaturationConditions(saturationTemperature, saturationPressure); tuning.run();
123123
* tuning.getSimulation().getThermoSystem().display();

src/main/java/neqsim/PVTsimulation/simulation/SaturationTemperature.java

+1-1
Original file line numberDiff line numberDiff line change
@@ -108,7 +108,7 @@ public static void main(String[] args) {
108108
// satPresSim.getThermoSystem().display();
109109
/*
110110
* double saturationPressure = 350.0; double saturationTemperature = 273.15 + 80;
111-
*
111+
*
112112
* TuningInterface tuning = new TuneToSaturation(satPresSim);
113113
* tuning.setSaturationConditions(saturationTemperature, saturationPressure); tuning.run();
114114
* tuning.getSimulation().getThermoSystem().display();

src/main/java/neqsim/chemicalReactions/chemicalEquilibriaum/ChemicalEquilibrium.java

+6-6
Original file line numberDiff line numberDiff line change
@@ -517,9 +517,9 @@ public double innerStep(int i, double[] n_omega, int check, double step, boolean
517517
* public double step(){ double step=1.0; int i, check=0; double[] F = new double[NSPEC]; double[]
518518
* F_omega = new double[NSPEC]; double[] chem_pot = new double[NSPEC]; double[] n_omega = new
519519
* double[NSPEC];
520-
*
520+
*
521521
* Matrix F_matrix, F_omega_matrix, fs_matrix, f_matrix, f_omega_matrix; double fs,f,f_omega;
522-
*
522+
*
523523
* for(i = 0;i<NSPEC;i++){ n_omega[i] = n_mol[i]+d_n[i]; if (n_omega[i]<0){ check = i; return
524524
* step; } else { if(system.getPhase(phasenumb).getComponents()[components[i].
525525
* getComponentNumber()].getReferenceStateType().equals("solvent")){ F[i] =
@@ -537,18 +537,18 @@ public double innerStep(int i, double[] n_omega, int check, double step, boolean
537537
* Math.log(n_omega[i]) - Math.log(n_t) + Math.log(activityVec[i]));
538538
* System.out.println("F "+activityVec[i]);
539539
* system.addComponent(components[i].getComponentNumber(), -d_n[i], phasenumb); calcRefPot(); } }
540-
*
540+
*
541541
* F_matrix = new Matrix(F,1); //F_matrix.print(5,5); F_omega_matrix = new Matrix(F_omega,1);
542-
*
542+
*
543543
* //F_matrix = F_matrix.minus((A_Jama_matrix.transpose().times(x_solve.getMatrix(0,NELE-1,0,
544544
* 0))).transpose()); //F_omega_matrix =
545545
* F_omega_matrix.minus((A_Jama_matrix.transpose().times(x_solve.getMatrix(0,
546546
* NELE-1,0,0))).transpose());
547-
*
547+
*
548548
* fs_matrix = F_matrix.transpose().times(F_matrix); fs = (-1)*fs_matrix.get(0,0); f_matrix =
549549
* F_matrix.times(F_matrix.transpose()); f = 0.5*f_matrix.get(0,0); f_omega_matrix =
550550
* F_omega_matrix.times(F_omega_matrix.transpose()); f_omega = 0.5*f_omega_matrix.get(0,0);
551-
*
551+
*
552552
* step = (-1)*fs/(2*(f_omega-f-fs)); //System.out.println("f "+f);
553553
* //System.out.println("f_omega "+f_omega); //System.out.println("fs "+fs);
554554
* //System.out.println("step " + step); //if (step > 0.5) step = 0.5; return step; }

src/main/java/neqsim/chemicalReactions/chemicalEquilibriaum/LinearProgrammingChemicalEquilibrium.java

+25-41
Original file line numberDiff line numberDiff line change
@@ -202,101 +202,89 @@ public void changePrimaryComponents() {
202202
* //System.out.println("Ans"); //Ans.print(10,8); //Print statements added by Neeraj
203203
* System.out.println("lagranges: "); lagrangeTemp.print(10,2); System.out.println("refpot: ");
204204
* mutemp.print(10,2); System.out.println("A: "); atemp.print(10,2);
205-
*
206-
*
205+
*
207206
* Matrix rTemp = new Matrix(atemp.getRowDimension(),1); rTemp.set(0,0,inertMoles/bVector[0]);
208207
* for(int i=1;i<atemp.getRowDimension();i++){ rTemp.set(i,0, bVector[i]/bVector[0]); }
209-
*
208+
*
210209
* // System.out.println("rMatTemp: "); // rTemp.print(10,5);
211-
*
212-
*
213-
*
210+
*
214211
* Matrix zTemp = new Matrix(atemp.getRowDimension(),1); for(int
215212
* i=0;i<atemp.getRowDimension();i++){ //Neeraj -- Source of error //lagrange have very high +ve
216213
* values. So, their exp becomes infinity zTemp.set(i,0, Math.exp(lagrangeTemp.get(i,0))); }
217-
*
214+
*
218215
* System.out.println("zMatTemp: "); //zTemp.print(10,5);
219-
*
220-
*
216+
*
221217
* Matrix phiMatTemp = new Matrix(atemp.getRowDimension(),1);
222218
* //atemp.transpose().solve(mutemp.transpose()); for(int i=0;i<atemp.getRowDimension();i++) {
223219
* phiMatTemp.set(i,0,zTemp.get(i,0)); } for(int i=1;i<atemp.getRowDimension();i++){
224220
* phiMatTemp.set(0,0,phiMatTemp.get(0,0)*Math.pow(phiMatTemp.get(i,0),rTemp.get (i,0))); }
225221
* //System.out.println("phiMatTemp: "); //phiMatTemp.print(10,10);
226-
*
227-
*
228-
*
222+
*
229223
* Matrix betaTemp = atemp.copy(); for(int j=0;j<atemp.getColumnDimension();j++){
230224
* betaTemp.set(0,j,1.0 + rTemp.get(0,0)*atemp.get(0,j)); }
231-
*
225+
*
232226
* for(int i=1;i<atemp.getRowDimension();i++) { for(int j=0;j<atemp.getColumnDimension();j++){
233227
* betaTemp.set(i,j,atemp.get(i,j)-rTemp.get(i,0)*atemp.get(0,j)); } }
234-
*
228+
*
235229
* // System.out.println("betaTemp: "); // betaTemp.print(10,10);
236-
*
237-
*
230+
*
238231
* Matrix alphaTemp = betaTemp.copy(); for(int j=0;j<Amatrix[0].length;j++){
239232
* alphaTemp.set(0,j,atemp.get(0,j)); } // System.out.println("alphaTemp: ");
240233
* alphaTemp.print(10,10);
241-
*
242-
*
234+
*
243235
* do{ double[] fVal = new double[atemp.getRowDimension()]; double[][] dfVal = new
244236
* double[atemp.getRowDimension()][atemp.getRowDimension()];
245-
*
237+
*
246238
* //creates f-vlas
247-
*
248-
*
239+
*
249240
* for(int i=0;i<atemp.getRowDimension();i++) { fVal[i]=0; for(int
250241
* j=0;j<atemp.getColumnDimension();j++){ double phiTemp = 1.0; for(int
251242
* k=0;k<atemp.getRowDimension();k++) { phiTemp =
252243
* phiTemp*Math.pow(phiMatTemp.get(k,0),alphaTemp.get(k,j)); } fVal[i] +=
253244
* betaTemp.get(i,j)*Math.exp(-chemRefPot[j]/(R*system.getPhase(phase).
254245
* getTemperature()))*phiTemp; } // System.out.println("fval: " + fVal[i]); } fVal[0] = fVal[0] -
255246
* 1.0;
256-
*
247+
*
257248
* for(int i=0;i<atemp.getRowDimension();i++){ for(int j=0;j<atemp.getRowDimension();j++) {
258249
* for(int k=0;k<atemp.getColumnDimension();k++){ double phiTemp = 1.0; for(int
259250
* p=0;p<atemp.getRowDimension();p++) { phiTemp =
260251
* phiTemp*Math.pow(phiMatTemp.get(p,0),alphaTemp.get(p,k)); } dfVal[i][j] +=
261252
* betaTemp.get(i,k)*alphaTemp.get(j,k)*Math.exp(-chemRefPot[k]/(R*system.
262253
* getPhase(phase).getTemperature()))*phiTemp; } } }
263-
*
264-
*
254+
*
265255
* // System.out.println("solved: "); Matrix fMatrix = new Matrix(fVal,1); Matrix dfMatrix = new
266256
* Matrix(dfVal); solved = dfMatrix.solve(fMatrix.timesEquals(-1.0).transpose());
267-
*
257+
*
268258
* //fMatrix.print(10,2); //dfMatrix.print(10,2); //System.out.println("solved: ");
269259
* //solved.print(10,6);
270-
*
260+
*
271261
* for(int i=0;i<atemp.getRowDimension();i++) {
272262
* phiMatTemp.set(i,0,Math.exp(solved.get(i,0))*phiMatTemp.get(i,0)); }
273263
* //System.out.println("phiMatTemp: "); //phiMatTemp.print(10,10); }
274264
* while(Math.abs(solved.norm2())>1e-10);
275-
*
265+
*
276266
* double temp=1.0; for(int i=1;i<atemp.getRowDimension();i++) { zTemp.set(i,0,
277267
* phiMatTemp.get(i,0)); temp = temp*Math.pow(zTemp.get(i,0),rTemp.get(i,0)); }
278268
* zTemp.set(0,0,phiMatTemp.get(0,0)/temp);
279-
*
269+
*
280270
* xEts = new double[atemp.getColumnDimension()]; double sum=0; for(int
281271
* k=0;k<atemp.getColumnDimension();k++){ xEts[k] =
282272
* Math.exp(-chemRefPot[k]/(R*system.getPhase(0).getTemperature()));
283273
* //System.out.println("x check1: " + xEts[k]); for(int i=0;i<atemp.getRowDimension();i++) {
284274
* xEts[k] = xEts[k]*Math.pow(zTemp.get(i,0),atemp.get(i,k)); } sum += xEts[k];
285275
* //System.out.println("x check2: " + xEts[k]); } //System.out.println("sum: " + sum);
286-
*
276+
*
287277
* double moles=0; for(int k=0;k<atemp.getColumnDimension();k++){ moles += xEts[k]*atemp.get(0,k);
288278
* } //Print added by Neeraj //System.out.println("mole tot " + moles); moles = 1.0/moles *
289279
* bVector[0];
290-
*
291-
*
280+
*
292281
* double[] nEts = new double[atemp.getColumnDimension()]; double totm=0.0; for(int
293282
* k=0;k<atemp.getColumnDimension();k++){ nEts[k] = xEts[k]*moles;
294283
* //system.getPhases()[1].getNumberOfMolesInPhase(); totm += nEts[k];
295284
* //System.out.println("N check: " + " comp " + components[k].getComponentName() + " " +
296285
* nEts[k]); } //System.out.println("tot moles : " + system.getPhase(1).getNumberOfMolesInPhase()
297286
* + " tot " +totm);
298-
*
299-
*
287+
*
300288
* return nEts; }
301289
*/
302290

@@ -327,15 +315,11 @@ public void calcx(Matrix atemp, Matrix lagrangeTemp) {
327315
* btemp; Matrix mutemp = new
328316
* Matrix(chemRefPot,1).times(1.0/(R*system.getPhase(phase).getTemperature())). copy(); Matrix
329317
* ntemp; atemp = new Matrix(7,7); btemp = new Matrix(1,7); //for (i=0;i<4;i++) for (i=0;i<5;i++)
330-
* { for (j=0;j<7;j++) atemp.set(i,j,Amatrix[i][j]); btemp.set(0,i,bVector[i]);
331-
*
332-
* } atemp.set(5,4,1); atemp.set(6,5,1); //atemp.set(4,4,1); //atemp.set(5,5,1);
333-
* //atemp.set(6,1,1); //atemp.print(5,1); //btemp.print(5,5); //mutemp.print(5,5); ntemp =
318+
* { for (j=0;j<7;j++) atemp.set(i,j,Amatrix[i][j]); btemp.set(0,i,bVector[i]); }
319+
* atemp.set(5,4,1); atemp.set(6,5,1); //atemp.set(4,4,1); //atemp.set(5,5,1); //atemp.set(6,1,1);
320+
* //atemp.print(5,1); //btemp.print(5,5); //mutemp.print(5,5); ntemp =
334321
* atemp.solve(btemp.transpose()); ntemp.print(5,5); for (i=0;i<7;i++) n[i] = ntemp.get(i,0); int
335-
* rank = atemp.rank(); return n;
336-
*
337-
*
338-
* }
322+
* rank = atemp.rank(); return n; }
339323
*/
340324

341325
// Method updated to use Apache Commons Math 3 by Marlene 07.12.18

src/main/java/neqsim/chemicalReactions/chemicalReaction/ChemicalReaction.java

-1
Original file line numberDiff line numberDiff line change
@@ -57,7 +57,6 @@ public ChemicalReaction(String name, String[] names, double[] stocCoefs, double[
5757
double activationEnergy, double refT) {
5858
/*
5959
* this.names = names; this.stocCoefs = stocCoefs; this.K = K;
60-
*
6160
*/
6261
super(name);
6362
this.names = new String[names.length];

src/main/java/neqsim/fluidMechanics/flowNode/multiPhaseNode/waxNode/WaxDepositionFlowNode.java

+4-5
Original file line numberDiff line numberDiff line change
@@ -161,21 +161,20 @@ public static void main(String[] args) {
161161

162162
/*
163163
* double length = 0;
164-
*
164+
*
165165
* double[][] temperatures2 = new double[3][1000]; int k = 0; for (int i = 0; i < 11; i++) {
166166
* length += test.getLengthOfNode(); test.initFlowCalc(); test.calcFluxes(); if (i > 1 && (i %
167167
* 1) == 0) { k++; test.display("length " + length); test.getBulkSystem().display("length " +
168168
* length); test.getInterphaseSystem().display("length " + length);
169169
* //test.getFluidBoundary().display("length " + length); test.setLengthOfNode(0.000005 +
170170
* test.getLengthOfNode() / 2.0); temperatures2[0][k] = length; temperatures2[1][k] =
171171
* test.getGeometry().getTemperature(); test.getFluidBoundary().display("test"); }
172-
*
172+
*
173173
* //test.getBulkSystem().display(); test.update(); test.getFluidBoundary().display("length " +
174174
* length); test.getInterphaseSystem().display("length " + length);
175-
*
176-
*
175+
*
177176
* //test.getFluidBoundary().display("test"); }
178-
*
177+
*
179178
* for (int i = 0; i < k; i++) { System.out.println("len temp " + temperatures2[0][i] + " " +
180179
* temperatures2[1][i]); }
181180
*/

src/main/java/neqsim/fluidMechanics/flowNode/twoPhaseNode/twoPhaseReactorFlowNode/TwoPhaseTrayTowerFlowNode.java

+1-1
Original file line numberDiff line numberDiff line change
@@ -132,7 +132,7 @@ public static void main(String[] args) {
132132
* System.out.println("Starter....."); SystemSrkEos testSystem = new SystemSrkEos(275.3,
133133
* ThermodynamicConstantsInterface.referencePressure); ThermodynamicOperations testOps = new
134134
* ThermodynamicOperations(testSystem); PipeData pipe1 = new PipeData(10.0, 0.025);
135-
*
135+
*
136136
* testSystem.addComponent("methane", 0.011152181, 0); testSystem.addComponent("ethane",
137137
* 0.00011152181, 0); testSystem.addComponent("water", 0.00462204876, 1);
138138
* testSystem.addComponent("methane", 0.061152181, 0); testSystem.addComponent("water",

src/main/java/neqsim/fluidMechanics/flowSolver/twoPhaseFlowSolver/twoPhasePipeFlowSolver/TwoPhaseFixedStaggeredGridSolver.java

+2-2
Original file line numberDiff line numberDiff line change
@@ -155,7 +155,7 @@ public void initProfiles() {
155155

156156
/*
157157
* do{ err=0; pipe.getNode(0).init(); for(int i = 0;i<numberOfNodes-1;i++){
158-
*
158+
*
159159
* //setting temperatures oldTemp = pipe.getNode(i+1).getBulkSystem().getTemperature(); dpdx =
160160
* (pipe.getNode(i+1).getBulkSystem().getPressure()-pipe.getNode(i).
161161
* getBulkSystem().getPressure())/((pipe.getNode(i+1).getGeometry().
@@ -170,7 +170,7 @@ public void initProfiles() {
170170
* ).getPhases()[0].getJouleThomsonCoefficient()*dpdx)*(pipe.getNode(i+1).
171171
* getGeometry().getNodeLength()+pipe.getNode(i).getGeometry().getNodeLength())* 0.5 +
172172
* pipe.getNode(i).getBulkSystem().getTemperature()); pipe.getNode(i+1).init();
173-
*
173+
*
174174
* // setting pressures oldPres = pipe.getNode(i+1).getBulkSystem().getPressure();
175175
* pipe.getNode(i+1).getBulkSystem().setPressure(-pipe.getNode(i). getWallFrictionFactor()*
176176
* pipe.getNode(i).getBulkSystem().getPhases()[0].getDensity()*pipe.velocity[i]*

src/main/java/neqsim/fluidMechanics/util/fluidMechanicsVisualization/flowSystemVisualization/onePhaseFlowVisualization/pipeFlowVisualization/PipeFlowVisualization.java

+2-2
Original file line numberDiff line numberDiff line change
@@ -103,7 +103,7 @@ public void calcPoints(String name) {
103103
}
104104
/*
105105
* try { System.out.println("points: " + points.length);
106-
*
106+
*
107107
* if (pressurePoint.length > 1) { System.out.println("3D plot "); plot = new
108108
* neqsim.dataPresentation.visAD.visAd3D.visAd3DPlot("title[0]", "title[1]", "title[2]");
109109
* ((neqsim.dataPresentation.visAD.visAd3D.visAd3DPlot) plot).setXYvals(150, 160,
@@ -138,7 +138,7 @@ public void displayResult(String name) {
138138
}
139139
/*
140140
* try { System.out.println("points: " + points.length);
141-
*
141+
*
142142
* if (pressurePoint.length > 1) { System.out.println("3D plot "); plot = new
143143
* neqsim.dataPresentation.visAD.visAd3D.visAd3DPlot("title[0]", "title[1]", "title[2]");
144144
* ((neqsim.dataPresentation.visAD.visAd3D.visAd3DPlot) plot).setXYvals(150, 160,

src/main/java/neqsim/fluidMechanics/util/fluidMechanicsVisualization/flowSystemVisualization/twoPhaseFlowVisualization/twoPhasePipeFlowVisualization/TwoPhasePipeFlowVisualization.java

+1-1
Original file line numberDiff line numberDiff line change
@@ -175,7 +175,7 @@ public void displayResult(String name) {
175175
* file.setYvalues(interfaceTemperaturePoint[0][0], "gas interface temperature", "sec");
176176
* file.setYvalues(interfaceTemperaturePoint[1][0], "liquid interface temperature", "sec");
177177
* file.setYvalues(interphaseContactLength[0][0], "interphase contact length", "sec");
178-
*
178+
*
179179
* for (int p = 0; p < flowNodes[0][0].getNumberOfComponents(); p++) { String comp =
180180
* "component molefraction " + p; file.setYvalues(bulkComposition[0][p][0], ("gas " + comp + p),
181181
* "sec"); file.setYvalues(bulkComposition[1][p][0], ("liquid " + comp + p), "sec");

src/main/java/neqsim/physicalProperties/interfaceProperties/surfaceTension/GTSurfaceTension.java

-3
Original file line numberDiff line numberDiff line change
@@ -15,7 +15,6 @@
1515
* method assumes the number of components to be two or more, and that the species set is equal and
1616
* in the same component order for both phases.
1717
*
18-
*
1918
* Near a fluid-fluid interface, we consider the variation of densities of chemical species,
2019
* \f$\boldsymbol{n}(z)\f$, as function of position, \f$z\f$, where element \f$k\f$ of the vector
2120
* \f$\boldsymbol{n}(z)\f$ is the number density of chemical species \f$k\f$ in the mixture. The
@@ -185,7 +184,6 @@ public static double solveWithRefcomp(SystemInterface system, int interface1, in
185184
* Tolerances for the odesystem.abstol and .reltol should be less than the integrator tolerances
186185
* for stability. Default Newton-Rhapson values are odesystem.normtol = 1e-10; odesystem.reltol
187186
* = 1e-8;
188-
*
189187
*/
190188
odesystem.normtol = 1e-10;
191189
odesystem.reltol = 1e-8;
@@ -216,7 +214,6 @@ public static double solveWithRefcomp(SystemInterface system, int interface1, in
216214
* results. The boundary conditions are the homogeneous densities of the two fluids in contact, as
217215
* calculated by a flash calculation.
218216
*
219-
*
220217
* We approximate the solution on a equi-spaced grid with \f$2^N+1\f$ points where \f$N\f$ is an
221218
* integer. Using a Finite Difference approximation, the equation for \f$\delta\mu\f$ can then be
222219
* written as an equation system for the internal grid points, \f$i=2,3,...,2^N\f$:

src/main/java/neqsim/physicalProperties/physicalPropertyMethods/commonPhasePhysicalProperties/conductivity/PFCTConductivityMethodMod86.java

+1-1
Original file line numberDiff line numberDiff line change
@@ -318,7 +318,7 @@ public double calcMixLPViscosity() {
318318
* phase.getPhase().getComponent(i).getx() *
319319
* Math.pow(phase.getPhase().getComponent(i).getMolarMass(), 2.0); Mmtemp +=
320320
* phase.getPhase().getComponent(i).getx() * phase.getPhase().getComponent(i).getMolarMass(); }
321-
*
321+
*
322322
* PCmix = 8.0 * tempPC1 / (tempPC2 * tempPC2); TCmix = tempTC1 / tempTC2; Mmix = (Mmtemp +
323323
* 1.304e-4 * (Math.pow(Mwtemp / Mmtemp, 2.303) - Math.pow(Mmtemp, 2.303))) * 1e3;
324324
* //phase.getPhase().getMolarMass();

src/main/java/neqsim/physicalProperties/physicalPropertyMethods/commonPhasePhysicalProperties/viscosity/Viscosity.java

+1
Original file line numberDiff line numberDiff line change
@@ -4,6 +4,7 @@
44
import org.apache.logging.log4j.Logger;
55

66
/**
7+
* Abstract class for Viscosity property.
78
*
89
* @author Even Solbraa
910
*/

src/main/java/neqsim/physicalProperties/physicalPropertyMethods/gasPhysicalProperties/conductivity/Conductivity.java

+1
Original file line numberDiff line numberDiff line change
@@ -10,6 +10,7 @@
1010
import org.apache.logging.log4j.Logger;
1111

1212
/**
13+
* Abstract class Conductivity.
1314
*
1415
* @author Even Solbraa
1516
*/

src/main/java/neqsim/physicalProperties/physicalPropertyMethods/gasPhysicalProperties/viscosity/Viscosity.java

+2-1
Original file line numberDiff line numberDiff line change
@@ -4,7 +4,8 @@
44
import org.apache.logging.log4j.Logger;
55

66
/**
7-
*
7+
* * Abstract class for Viscosity property.
8+
*
89
* @author Even Solbraa
910
*/
1011
abstract class Viscosity extends

src/main/java/neqsim/processSimulation/mechanicalDesign/pipeline/PipelineMechanicalDesign.java

+1-1
Original file line numberDiff line numberDiff line change
@@ -59,7 +59,7 @@ public void calcDesign() {
5959
/*
6060
* Pipeline pipeline = (Pipeline) getProcessEquipment(); double flow = ((AdiabaticPipe)
6161
* getProcessEquipment()).getOutStream().getThermoSystem().getVolume() / 1e5;
62-
*
62+
*
6363
* double innerArea = Math.PI * innerDiameter * innerDiameter / 4.0; double gasVelocity = flow /
6464
* innerArea; double wallThickness = 0.0;
6565
*/

src/main/java/neqsim/processSimulation/processEquipment/ProcessEquipmentInterface.java

-1
Original file line numberDiff line numberDiff line change
@@ -45,7 +45,6 @@ default void initMechanicalDesign() {}
4545
* </p>
4646
*
4747
* @return true or false
48-
*
4948
*/
5049
public default boolean needRecalculation() {
5150
return true;

src/main/java/neqsim/processSimulation/processEquipment/compressor/CompressorChartAlternativeMapLookup.java

+1-1
Original file line numberDiff line numberDiff line change
@@ -428,7 +428,7 @@ public static void main(String[] args) {
428428
* double[] surgeflow = new double[] { 453.2, 550.0, 700.0, 800.0 }; double[] surgehead = new
429429
* double[] { 6000.0, 7000.0, 8000.0, 10000.0 };
430430
* comp1.getCompressorChart().getSurgeCurve().setCurve(chartConditions, surgeflow, surgehead);
431-
*
431+
*
432432
* double[] stoneWallflow = new double[] { 923.2, 950.0, 980.0, 1000.0 }; double[] stoneWallHead
433433
* = new double[] { 6000.0, 7000.0, 8000.0, 10000.0 };
434434
* comp1.getCompressorChart().getStoneWallCurve().setCurve(chartConditions, stoneWallflow,

src/main/java/neqsim/processSimulation/processEquipment/expander/Expander.java

+2-5
Original file line numberDiff line numberDiff line change
@@ -89,7 +89,6 @@ public void run(UUID id) {
8989
/*
9090
* HYSYS method double oldPolyt = 10.5; int iter = 0; do {
9191
*
92-
*
9392
* iter++; double n = Math.log(thermoSystem.getPressure() / presinn) /
9493
* Math.log(thermoSystem.getDensity() / densInn); double k =
9594
* Math.log(thermoSystem.getPressure() / presinn) / Math.log(densOutIdeal / densInn); double
@@ -98,11 +97,9 @@ public void run(UUID id) {
9897
* 1.0); oldPolyt = polytropicEfficiency; polytropicEfficiency = factor *
9998
* isentropicEfficiency; dH = thermoSystem.getEnthalpy() - hinn; hout = hinn + dH /
10099
* polytropicEfficiency; thermoOps.PHflash(hout, 0); System.out.println(" factor " + factor +
101-
* " n " + n + " k " + k + " polytropic effici " + polytropicEfficiency + " iter " + iter);
102-
*
103-
* } while (Math.abs((oldPolyt - polytropicEfficiency) / oldPolyt) > 1e-5 && iter < 500); //
100+
* " n " + n + " k " + k + " polytropic effici " + polytropicEfficiency + " iter " + iter); }
101+
* while (Math.abs((oldPolyt - polytropicEfficiency) / oldPolyt) > 1e-5 && iter < 500); //
104102
* polytropicEfficiency = isentropicEfficiency * ();
105-
*
106103
*/
107104
} else {
108105
getThermoSystem().setPressure(pressure);

0 commit comments

Comments
 (0)