HyPar  1.0
Finite-Difference Hyperbolic-Parabolic PDE Solver on Cartesian Grids
Steady, incompressible, viscous flow around an isothermal sphere

Location: hypar/Examples/3D/NavierStokes3D/Sphere/Steady_Viscous_Incompressible_Isothermal

Governing equations: 3D Navier-Stokes Equations (navierstokes3d.h)

Domain: The domain consists of a fine uniform grid around the sphere defined by [-2,6] X [-2,2] X [-2,2], and a stretched grid beyond this zone.

Geometry: A sphere of radius 0.5 centered at (0,0) (hypar/Examples/STLGeometries/sphere.stl)

The following image shows the sphere:

Surface3D_Sphere.png

The following images shows the grid and the sphere:

Domain3D_Sphere1.png
Domain3D_Sphere2.png

Boundary conditions:

Initial solution: \(\rho=1, u=0.1, v=w=0, p=1/\gamma\) everywhere in the domain.

Other parameters (all dimensional quantities are in SI units):

  • Specific heat ratio \(\gamma = 1.4\) (NavierStokes3D::gamma)
  • Freestream Mach number \(M_{\infty} = 0.1\) (NavierStokes3D::Minf)
  • Prandlt number \(Pr = 0.72\) (NavierStokes3D::Pr)
  • Reynolds number \(Re = \frac {\rho u L } {\mu} = 100\) (NavierStokes3D::Re) (Note: since the diameter of the sphere is 1.0, the diameter-based Reynolds number is the same as the specified Reynolds number \(Re_D = Re = 100\)).

Numerical Method:

Input files required:

These files are all located in: hypar/Examples/3D/NavierStokes3D/Sphere/Steady_Viscous_Incompressible_Isothermal/

solver.inp

begin
ndims 3
nvars 5
size 200 96 96
iproc 8 4 4
ghost 3
n_iter 25000
time_scheme rk
time_scheme_type 44
hyp_space_scheme weno5
hyp_interp_type components
par_space_type nonconservative-2stage
par_space_scheme 4
dt 0.025
screen_op_iter 25
file_op_iter 100
ip_file_type binary
op_file_format binary
op_overwrite yes
model navierstokes3d
immersed_body sphere.stl
end

boundary.inp

6
subsonic-inflow 0 1 0 0 -9999.0 9999.0 -9999.0 9999.0
1.0 0.1 0.0 0.0
subsonic-outflow 0 -1 0 0 -9999.0 9999.0 -9999.0 9999.0
0.7142857142857143
subsonic-ambivalent 1 1 -9999.0 9999.0 0 0 -9999.0 9999.0
1.0 0.1 0.0 0.0 0.7142857142857143
subsonic-ambivalent 1 -1 -9999.0 9999.0 0 0 -9999.0 9999.0
1.0 0.1 0.0 0.0 0.7142857142857143
subsonic-ambivalent 2 1 -9999.0 9999.0 -9999.0 9999.0 0 0
1.0 0.1 0.0 0.0 0.7142857142857143
subsonic-ambivalent 2 -1 -9999.0 9999.0 -9999.0 9999.0 0 0
1.0 0.1 0.0 0.0 0.7142857142857143

physics.inp : The following file specifies a Reynolds number of 100. To try other Reynolds numbers, change it here. This file also specifies the sphere wall temperature as the same as the freestream temperature.

begin
gamma 1.4
upwinding roe
Pr 0.72
Minf 0.1
Re 100
ib_wall_type isothermal 0.7142857142857143
end

sphere.stl : the filename "sphere.stl" must match the input for immersed_body in solver.inp.
Located at hypar/Examples/STLGeometries/sphere.stl

To generate initial.inp (initial solution), compile and run the following code in the run directory.

#include <stdio.h>
#include <stdlib.h>
#include <math.h>
#include <string.h>
int main()
{
const double GAMMA = 1.4;
int NI,NJ,NK,ndims;
char ip_file_type[50];
FILE *in;
strcpy(ip_file_type,"ascii");
printf("Reading file \"solver.inp\"...\n");
in = fopen("solver.inp","r");
if (!in) {
printf("Error: Input file \"solver.inp\" not found.\n");
return(0);
} else {
char word[500];
fscanf(in,"%s",word);
if (!strcmp(word, "begin")){
while (strcmp(word, "end")){
fscanf(in,"%s",word);
if (!strcmp(word, "ndims")) {
fscanf(in,"%d",&ndims);
} else if (!strcmp(word, "size" )) {
fscanf(in,"%d",&NI);
fscanf(in,"%d",&NJ);
fscanf(in,"%d",&NK);
} else if (!strcmp(word, "ip_file_type")) {
fscanf(in,"%s",ip_file_type);
}
}
} else {
printf("Error: Illegal format in solver.inp. Crash and burn!\n");
return(0);
}
}
fclose(in);
if (ndims != 3) {
printf("Error: ndims is not 3 in solver.inp.\n");
return(0);
}
printf("Grid: %3d x %3d x %3d.\n",NI,NJ,NK);
double Lx = 8.0;
double Ly = 4.0;
double Lz = 4.0;
double sf_x1 = 1.15;
double sf_x2 = 1.20;
double sf_y = 1.4;
double sf_z = 1.4;
int i,j,k;
double u = 0.1,
v = 0.0,
w = 0.0,
rho = 1.0,
P = 1.0/GAMMA;
double *x, *y, *z, *U;
double dx, dy, dz;
FILE *out;
x = (double*) calloc (NI , sizeof(double));
y = (double*) calloc (NJ , sizeof(double));
z = (double*) calloc (NK , sizeof(double));
U = (double*) calloc (5*NI*NJ*NK, sizeof(double));
x[NI/8] = -Lx/4;
x[7*NI/8] = 3*Lx/4;
dx = Lx / ((double)(6*NI/8-1));
for (i = NI/8 ; i < 7*NI/8; i++) x[i] = x[NI/8] + dx * (i-NI/8);
for (i = 7*NI/8; i < NI ; i++) x[i] = x[i-1] + sf_x2 * (x[i-1] - x[i-2]);
for (i = NI/8-1; i >= 0 ; i--) x[i] = x[i+1] - sf_x1 * (x[i+2] - x[i+1]);
y[NJ/8] = -Ly/2;
y[7*NJ/8] = Ly/2;
dy = Ly / ((double)(6*NJ/8-1));
for (j = NJ/8 ; j < 7*NJ/8; j++) y[j] = y[NJ/8] + dy * (j-NJ/8);
for (j = 7*NJ/8; j < NJ ; j++) y[j] = y[j-1] + sf_y * (y[j-1] - y[j-2]);
for (j = NJ/8-1; j >= 0 ; j--) y[j] = y[j+1] - sf_y * (y[j+2] - y[j+1]);
z[NK/8] = -Lz/2;
z[7*NK/8] = Lz/2;
dz = Lz / ((double)(6*NK/8-1));
for (k = NK/8 ; k < 7*NK/8; k++) z[k] = z[NK/8] + dz * (k-NK/8);
for (k = 7*NK/8; k < NK ; k++) z[k] = z[k-1] + sf_z * (z[k-1] - z[k-2]);
for (k = NK/8-1; k >= 0 ; k--) z[k] = z[k+1] - sf_z * (z[k+2] - z[k+1]);
for (i = 0; i < NI; i++){
for (j = 0; j < NJ; j++){
for (k = 0; k < NK; k++){
int p = i + NI*j + NI*NJ*k;
U[5*p+0] = rho;
U[5*p+1] = rho*u;
U[5*p+2] = rho*v;
U[5*p+3] = rho*w;
U[5*p+4] = P/(GAMMA-1.0) + 0.5*rho*(u*u+v*v+w*w);
}
}
}
if (!strcmp(ip_file_type,"ascii")) {
printf("Writing ASCII initial solution file initial.inp\n");
out = fopen("initial.inp","w");
for (i = 0; i < NI; i++) fprintf(out,"%1.16E ",x[i]);
fprintf(out,"\n");
for (j = 0; j < NJ; j++) fprintf(out,"%1.16E ",y[j]);
fprintf(out,"\n");
for (k = 0; k < NK; k++) fprintf(out,"%1.16E ",z[k]);
fprintf(out,"\n");
for (k = 0; k < NK; k++) {
for (j = 0; j < NJ; j++) {
for (i = 0; i < NI; i++) {
int p = i + NK*j + NI*NJ*k;
fprintf(out,"%1.16E ",U[5*p+0]);
}
}
}
fprintf(out,"\n");
for (k = 0; k < NK; k++) {
for (j = 0; j < NJ; j++) {
for (i = 0; i < NI; i++) {
int p = i + NK*j + NI*NJ*k;
fprintf(out,"%1.16E ",U[5*p+1]);
}
}
}
fprintf(out,"\n");
for (k = 0; k < NK; k++) {
for (j = 0; j < NJ; j++) {
for (i = 0; i < NI; i++) {
int p = i + NK*j + NI*NJ*k;
fprintf(out,"%1.16E ",U[5*p+2]);
}
}
}
fprintf(out,"\n");
for (k = 0; k < NK; k++) {
for (j = 0; j < NJ; j++) {
for (i = 0; i < NI; i++) {
int p = i + NK*j + NI*NJ*k;
fprintf(out,"%1.16E ",U[5*p+3]);
}
}
}
fprintf(out,"\n");
for (k = 0; k < NK; k++) {
for (j = 0; j < NJ; j++) {
for (i = 0; i < NI; i++) {
int p = i + NK*j + NI*NJ*k;
fprintf(out,"%1.16E ",U[5*p+4]);
}
}
}
fprintf(out,"\n");
fclose(out);
} else if ((!strcmp(ip_file_type,"binary")) || (!strcmp(ip_file_type,"bin"))) {
printf("Writing binary initial solution file initial.inp\n");
out = fopen("initial.inp","wb");
fwrite(x,sizeof(double),NI,out);
fwrite(y,sizeof(double),NJ,out);
fwrite(z,sizeof(double),NK,out);
fwrite(U,sizeof(double),5*NI*NJ*NK,out);
fclose(out);
}
free(x);
free(y);
free(z);
free(U);
return(0);
}

Output:

Note that iproc is set to

  8 4 4

in solver.inp (i.e., 8 processors along x, 4 processors along y, and 4 processor along z). Thus, this example should be run with 128 MPI ranks (or change iproc).

After running the code, there should be one output file op.bin, since HyPar::op_overwrite is set to yes in solver.inp. HyPar::op_file_format is set to binary in solver.inp, and thus, all the files are written out in the binary format, see WriteBinary(). The binary file contains the conserved variables \(\left(\rho, \rho u, \rho v, e\right)\). The following two codes are available to convert the binary output file:

  • hypar/Extras/BinaryToTecplot.c - convert binary output file to Tecplot file.
  • hypar/Extras/BinaryToText.c - convert binary output file to an ASCII text file (to visualize in, for example, MATLAB).

The following figure shows the flow (pressure and streamlines) at \(Re_D=100\):

Solution_3DNavStokSphereIsothermal_ReD100.png

In addition to the main solution, the code also writes out a file with the aerodynamic forces on the immersed body. This file is called surface.dat (if HyPar::op_overwrite is "yes") or surface_nnnnn.dat (if HyPar::op_overwrite is "no", "nnnnn" is a numerical index) (in this example, the file surface.dat is written out). This is an ASCII file in the Tecplot format, where the immersed body and the forces on it are represented using the "FETRIANGLE" type. The following image shows the surface pressure and temperature on the sphere (front-view):

IBSurface_3DNavStokSphereIsothermal_Pressure.png
IBSurface_3DNavStokSphereIsothermal_Temperature.png

Expected screen output:

HyPar - Parallel (MPI) version with 128 processes
Compiled with PETSc time integration.
Allocated simulation object(s).
Reading solver inputs from file "solver.inp".
No. of dimensions : 3
No. of variables : 5
Domain size : 200 96 96
Processes along each dimension : 8 4 4
No. of ghosts pts : 3
No. of iter. : 25000
Restart iteration : 0
Time integration scheme : rk (44)
Spatial discretization scheme (hyperbolic) : weno5
Split hyperbolic flux term? : no
Interpolation type for hyperbolic term : components
Spatial discretization type (parabolic ) : nonconservative-2stage
Spatial discretization scheme (parabolic ) : 4
Time Step : 2.500000E-02
Check for conservation : no
Screen output iterations : 25
File output iterations : 100
Initial solution file type : binary
Initial solution read mode : serial
Solution file write mode : serial
Solution file format : binary
Overwrite solution file : yes
Physical model : navierstokes3d
Immersed Body : sphere.stl
Partitioning domain and allocating data arrays.
Reading array from binary file initial.inp (Serial mode).
Volume integral of the initial solution:
0: 4.6753965134569866E+04
1: 4.6753965134569362E+03
2: 0.0000000000000000E+00
3: 0.0000000000000000E+00
4: 8.3722993280261522E+04
Reading boundary conditions from boundary.inp.
Boundary subsonic-inflow: Along dimension 0 and face +1
Boundary subsonic-outflow: Along dimension 0 and face -1
Boundary subsonic-ambivalent: Along dimension 1 and face +1
Boundary subsonic-ambivalent: Along dimension 1 and face -1
Boundary subsonic-ambivalent: Along dimension 2 and face +1
Boundary subsonic-ambivalent: Along dimension 2 and face -1
6 boundary condition(s) read.
Immersed body read from sphere.stl:
Number of facets: 12320
Bounding box: [-0.5,0.5] X [-0.5,0.5] X [-0.5,0.5]
Number of grid points inside immersed body: 3619 ( 0.2%).
Number of immersed boundary points : 1988 ( 0.1%).
Immersed body simulation mode : 3d.
Initializing solvers.
Warning: File weno.inp not found. Using default parameters for WENO5/CRWENO5/HCWENO5 scheme.
Initializing physics. Model = "navierstokes3d"
Reading physical model inputs from file "physics.inp".
Writing solution file iblank.bin.
Setting up time integration.
Solving in time (from 0 to 25000 iterations)
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 25 Time: 6.250E-01 Max CFL: 6.298E-01 Max Diff. No.: -1.000E+00 Norm: 5.4190E-04
Iteration: 50 Time: 1.250E+00 Max CFL: 6.178E-01 Max Diff. No.: -1.000E+00 Norm: 5.1171E-04
Iteration: 75 Time: 1.875E+00 Max CFL: 5.931E-01 Max Diff. No.: -1.000E+00 Norm: 4.7475E-04
Iteration: 100 Time: 2.500E+00 Max CFL: 5.790E-01 Max Diff. No.: -1.000E+00 Norm: 3.9496E-04
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 125 Time: 3.125E+00 Max CFL: 5.720E-01 Max Diff. No.: -1.000E+00 Norm: 2.9920E-04
Iteration: 150 Time: 3.750E+00 Max CFL: 5.677E-01 Max Diff. No.: -1.000E+00 Norm: 2.3273E-04
Iteration: 175 Time: 4.375E+00 Max CFL: 5.643E-01 Max Diff. No.: -1.000E+00 Norm: 1.9151E-04
Iteration: 200 Time: 5.000E+00 Max CFL: 5.619E-01 Max Diff. No.: -1.000E+00 Norm: 1.6293E-04
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 225 Time: 5.625E+00 Max CFL: 5.599E-01 Max Diff. No.: -1.000E+00 Norm: 1.2611E-04
Iteration: 250 Time: 6.250E+00 Max CFL: 5.584E-01 Max Diff. No.: -1.000E+00 Norm: 7.7788E-05
Iteration: 275 Time: 6.875E+00 Max CFL: 5.571E-01 Max Diff. No.: -1.000E+00 Norm: 4.7907E-05
Iteration: 300 Time: 7.500E+00 Max CFL: 5.561E-01 Max Diff. No.: -1.000E+00 Norm: 2.9368E-05
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 325 Time: 8.125E+00 Max CFL: 5.552E-01 Max Diff. No.: -1.000E+00 Norm: 1.8949E-05
Iteration: 350 Time: 8.750E+00 Max CFL: 5.544E-01 Max Diff. No.: -1.000E+00 Norm: 1.3304E-05
Iteration: 375 Time: 9.375E+00 Max CFL: 5.537E-01 Max Diff. No.: -1.000E+00 Norm: 1.0100E-05
Iteration: 400 Time: 1.000E+01 Max CFL: 5.531E-01 Max Diff. No.: -1.000E+00 Norm: 8.2669E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 425 Time: 1.063E+01 Max CFL: 5.525E-01 Max Diff. No.: -1.000E+00 Norm: 6.9994E-06
Iteration: 450 Time: 1.125E+01 Max CFL: 5.520E-01 Max Diff. No.: -1.000E+00 Norm: 6.0819E-06
Iteration: 475 Time: 1.188E+01 Max CFL: 5.515E-01 Max Diff. No.: -1.000E+00 Norm: 5.5295E-06
Iteration: 500 Time: 1.250E+01 Max CFL: 5.510E-01 Max Diff. No.: -1.000E+00 Norm: 5.2081E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 525 Time: 1.313E+01 Max CFL: 5.506E-01 Max Diff. No.: -1.000E+00 Norm: 4.9893E-06
Iteration: 550 Time: 1.375E+01 Max CFL: 5.503E-01 Max Diff. No.: -1.000E+00 Norm: 4.8235E-06
Iteration: 575 Time: 1.438E+01 Max CFL: 5.501E-01 Max Diff. No.: -1.000E+00 Norm: 4.6830E-06
Iteration: 600 Time: 1.500E+01 Max CFL: 5.498E-01 Max Diff. No.: -1.000E+00 Norm: 4.5559E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 625 Time: 1.563E+01 Max CFL: 5.496E-01 Max Diff. No.: -1.000E+00 Norm: 4.4403E-06
Iteration: 650 Time: 1.625E+01 Max CFL: 5.495E-01 Max Diff. No.: -1.000E+00 Norm: 4.3311E-06
Iteration: 675 Time: 1.688E+01 Max CFL: 5.493E-01 Max Diff. No.: -1.000E+00 Norm: 4.2321E-06
Iteration: 700 Time: 1.750E+01 Max CFL: 5.491E-01 Max Diff. No.: -1.000E+00 Norm: 4.1405E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 725 Time: 1.813E+01 Max CFL: 5.490E-01 Max Diff. No.: -1.000E+00 Norm: 4.0535E-06
Iteration: 750 Time: 1.875E+01 Max CFL: 5.488E-01 Max Diff. No.: -1.000E+00 Norm: 3.9700E-06
Iteration: 775 Time: 1.937E+01 Max CFL: 5.487E-01 Max Diff. No.: -1.000E+00 Norm: 3.8891E-06
Iteration: 800 Time: 2.000E+01 Max CFL: 5.485E-01 Max Diff. No.: -1.000E+00 Norm: 3.8109E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 825 Time: 2.062E+01 Max CFL: 5.484E-01 Max Diff. No.: -1.000E+00 Norm: 3.7366E-06
Iteration: 850 Time: 2.125E+01 Max CFL: 5.483E-01 Max Diff. No.: -1.000E+00 Norm: 3.6665E-06
Iteration: 875 Time: 2.187E+01 Max CFL: 5.482E-01 Max Diff. No.: -1.000E+00 Norm: 3.5998E-06
Iteration: 900 Time: 2.250E+01 Max CFL: 5.480E-01 Max Diff. No.: -1.000E+00 Norm: 3.5361E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 925 Time: 2.312E+01 Max CFL: 5.479E-01 Max Diff. No.: -1.000E+00 Norm: 3.4746E-06
Iteration: 950 Time: 2.375E+01 Max CFL: 5.478E-01 Max Diff. No.: -1.000E+00 Norm: 3.4150E-06
Iteration: 975 Time: 2.437E+01 Max CFL: 5.477E-01 Max Diff. No.: -1.000E+00 Norm: 3.3574E-06
Iteration: 1000 Time: 2.500E+01 Max CFL: 5.476E-01 Max Diff. No.: -1.000E+00 Norm: 3.3017E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1025 Time: 2.562E+01 Max CFL: 5.475E-01 Max Diff. No.: -1.000E+00 Norm: 3.2479E-06
Iteration: 1050 Time: 2.625E+01 Max CFL: 5.474E-01 Max Diff. No.: -1.000E+00 Norm: 3.1964E-06
Iteration: 1075 Time: 2.687E+01 Max CFL: 5.473E-01 Max Diff. No.: -1.000E+00 Norm: 3.1470E-06
Iteration: 1100 Time: 2.750E+01 Max CFL: 5.472E-01 Max Diff. No.: -1.000E+00 Norm: 3.0990E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1125 Time: 2.812E+01 Max CFL: 5.471E-01 Max Diff. No.: -1.000E+00 Norm: 3.0514E-06
Iteration: 1150 Time: 2.875E+01 Max CFL: 5.470E-01 Max Diff. No.: -1.000E+00 Norm: 3.0035E-06
Iteration: 1175 Time: 2.937E+01 Max CFL: 5.470E-01 Max Diff. No.: -1.000E+00 Norm: 2.9559E-06
Iteration: 1200 Time: 3.000E+01 Max CFL: 5.469E-01 Max Diff. No.: -1.000E+00 Norm: 2.9101E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1225 Time: 3.062E+01 Max CFL: 5.468E-01 Max Diff. No.: -1.000E+00 Norm: 2.8679E-06
Iteration: 1250 Time: 3.125E+01 Max CFL: 5.468E-01 Max Diff. No.: -1.000E+00 Norm: 2.8303E-06
Iteration: 1275 Time: 3.187E+01 Max CFL: 5.467E-01 Max Diff. No.: -1.000E+00 Norm: 2.7973E-06
Iteration: 1300 Time: 3.250E+01 Max CFL: 5.466E-01 Max Diff. No.: -1.000E+00 Norm: 2.7678E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1325 Time: 3.312E+01 Max CFL: 5.466E-01 Max Diff. No.: -1.000E+00 Norm: 2.7401E-06
Iteration: 1350 Time: 3.375E+01 Max CFL: 5.465E-01 Max Diff. No.: -1.000E+00 Norm: 2.7127E-06
Iteration: 1375 Time: 3.437E+01 Max CFL: 5.464E-01 Max Diff. No.: -1.000E+00 Norm: 2.6847E-06
Iteration: 1400 Time: 3.500E+01 Max CFL: 5.464E-01 Max Diff. No.: -1.000E+00 Norm: 2.6552E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1425 Time: 3.562E+01 Max CFL: 5.463E-01 Max Diff. No.: -1.000E+00 Norm: 2.6241E-06
Iteration: 1450 Time: 3.625E+01 Max CFL: 5.463E-01 Max Diff. No.: -1.000E+00 Norm: 2.5918E-06
Iteration: 1475 Time: 3.687E+01 Max CFL: 5.462E-01 Max Diff. No.: -1.000E+00 Norm: 2.5587E-06
Iteration: 1500 Time: 3.750E+01 Max CFL: 5.462E-01 Max Diff. No.: -1.000E+00 Norm: 2.5257E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1525 Time: 3.812E+01 Max CFL: 5.461E-01 Max Diff. No.: -1.000E+00 Norm: 2.4935E-06
Iteration: 1550 Time: 3.875E+01 Max CFL: 5.461E-01 Max Diff. No.: -1.000E+00 Norm: 2.4623E-06
Iteration: 1575 Time: 3.937E+01 Max CFL: 5.460E-01 Max Diff. No.: -1.000E+00 Norm: 2.4319E-06
Iteration: 1600 Time: 4.000E+01 Max CFL: 5.460E-01 Max Diff. No.: -1.000E+00 Norm: 2.4021E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1625 Time: 4.062E+01 Max CFL: 5.459E-01 Max Diff. No.: -1.000E+00 Norm: 2.3726E-06
Iteration: 1650 Time: 4.125E+01 Max CFL: 5.459E-01 Max Diff. No.: -1.000E+00 Norm: 2.3439E-06
Iteration: 1675 Time: 4.187E+01 Max CFL: 5.459E-01 Max Diff. No.: -1.000E+00 Norm: 2.3167E-06
Iteration: 1700 Time: 4.250E+01 Max CFL: 5.458E-01 Max Diff. No.: -1.000E+00 Norm: 2.2908E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1725 Time: 4.312E+01 Max CFL: 5.458E-01 Max Diff. No.: -1.000E+00 Norm: 2.2655E-06
Iteration: 1750 Time: 4.375E+01 Max CFL: 5.457E-01 Max Diff. No.: -1.000E+00 Norm: 2.2399E-06
Iteration: 1775 Time: 4.437E+01 Max CFL: 5.457E-01 Max Diff. No.: -1.000E+00 Norm: 2.2137E-06
Iteration: 1800 Time: 4.500E+01 Max CFL: 5.457E-01 Max Diff. No.: -1.000E+00 Norm: 2.1875E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1825 Time: 4.562E+01 Max CFL: 5.457E-01 Max Diff. No.: -1.000E+00 Norm: 2.1626E-06
Iteration: 1850 Time: 4.625E+01 Max CFL: 5.456E-01 Max Diff. No.: -1.000E+00 Norm: 2.1397E-06
Iteration: 1875 Time: 4.687E+01 Max CFL: 5.456E-01 Max Diff. No.: -1.000E+00 Norm: 2.1186E-06
Iteration: 1900 Time: 4.750E+01 Max CFL: 5.456E-01 Max Diff. No.: -1.000E+00 Norm: 2.0981E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 1925 Time: 4.812E+01 Max CFL: 5.455E-01 Max Diff. No.: -1.000E+00 Norm: 2.0771E-06
Iteration: 1950 Time: 4.875E+01 Max CFL: 5.455E-01 Max Diff. No.: -1.000E+00 Norm: 2.0553E-06
Iteration: 1975 Time: 4.937E+01 Max CFL: 5.455E-01 Max Diff. No.: -1.000E+00 Norm: 2.0334E-06
Iteration: 2000 Time: 5.000E+01 Max CFL: 5.455E-01 Max Diff. No.: -1.000E+00 Norm: 2.0124E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2025 Time: 5.062E+01 Max CFL: 5.454E-01 Max Diff. No.: -1.000E+00 Norm: 1.9927E-06
Iteration: 2050 Time: 5.125E+01 Max CFL: 5.454E-01 Max Diff. No.: -1.000E+00 Norm: 1.9744E-06
Iteration: 2075 Time: 5.187E+01 Max CFL: 5.454E-01 Max Diff. No.: -1.000E+00 Norm: 1.9572E-06
Iteration: 2100 Time: 5.250E+01 Max CFL: 5.454E-01 Max Diff. No.: -1.000E+00 Norm: 1.9409E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2125 Time: 5.312E+01 Max CFL: 5.453E-01 Max Diff. No.: -1.000E+00 Norm: 1.9249E-06
Iteration: 2150 Time: 5.375E+01 Max CFL: 5.453E-01 Max Diff. No.: -1.000E+00 Norm: 1.9091E-06
Iteration: 2175 Time: 5.437E+01 Max CFL: 5.453E-01 Max Diff. No.: -1.000E+00 Norm: 1.8932E-06
Iteration: 2200 Time: 5.500E+01 Max CFL: 5.453E-01 Max Diff. No.: -1.000E+00 Norm: 1.8767E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2225 Time: 5.562E+01 Max CFL: 5.452E-01 Max Diff. No.: -1.000E+00 Norm: 1.8596E-06
Iteration: 2250 Time: 5.625E+01 Max CFL: 5.452E-01 Max Diff. No.: -1.000E+00 Norm: 1.8418E-06
Iteration: 2275 Time: 5.687E+01 Max CFL: 5.452E-01 Max Diff. No.: -1.000E+00 Norm: 1.8234E-06
Iteration: 2300 Time: 5.750E+01 Max CFL: 5.452E-01 Max Diff. No.: -1.000E+00 Norm: 1.8047E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2325 Time: 5.812E+01 Max CFL: 5.452E-01 Max Diff. No.: -1.000E+00 Norm: 1.7862E-06
Iteration: 2350 Time: 5.875E+01 Max CFL: 5.451E-01 Max Diff. No.: -1.000E+00 Norm: 1.7678E-06
Iteration: 2375 Time: 5.937E+01 Max CFL: 5.451E-01 Max Diff. No.: -1.000E+00 Norm: 1.7498E-06
Iteration: 2400 Time: 6.000E+01 Max CFL: 5.451E-01 Max Diff. No.: -1.000E+00 Norm: 1.7320E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2425 Time: 6.062E+01 Max CFL: 5.451E-01 Max Diff. No.: -1.000E+00 Norm: 1.7143E-06
Iteration: 2450 Time: 6.125E+01 Max CFL: 5.451E-01 Max Diff. No.: -1.000E+00 Norm: 1.6964E-06
Iteration: 2475 Time: 6.187E+01 Max CFL: 5.450E-01 Max Diff. No.: -1.000E+00 Norm: 1.6784E-06
Iteration: 2500 Time: 6.250E+01 Max CFL: 5.450E-01 Max Diff. No.: -1.000E+00 Norm: 1.6603E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2525 Time: 6.312E+01 Max CFL: 5.450E-01 Max Diff. No.: -1.000E+00 Norm: 1.6421E-06
Iteration: 2550 Time: 6.375E+01 Max CFL: 5.450E-01 Max Diff. No.: -1.000E+00 Norm: 1.6237E-06
Iteration: 2575 Time: 6.437E+01 Max CFL: 5.450E-01 Max Diff. No.: -1.000E+00 Norm: 1.6051E-06
Iteration: 2600 Time: 6.500E+01 Max CFL: 5.450E-01 Max Diff. No.: -1.000E+00 Norm: 1.5862E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2625 Time: 6.562E+01 Max CFL: 5.449E-01 Max Diff. No.: -1.000E+00 Norm: 1.5672E-06
Iteration: 2650 Time: 6.625E+01 Max CFL: 5.449E-01 Max Diff. No.: -1.000E+00 Norm: 1.5481E-06
Iteration: 2675 Time: 6.687E+01 Max CFL: 5.449E-01 Max Diff. No.: -1.000E+00 Norm: 1.5290E-06
Iteration: 2700 Time: 6.750E+01 Max CFL: 5.449E-01 Max Diff. No.: -1.000E+00 Norm: 1.5102E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2725 Time: 6.812E+01 Max CFL: 5.449E-01 Max Diff. No.: -1.000E+00 Norm: 1.4915E-06
Iteration: 2750 Time: 6.875E+01 Max CFL: 5.449E-01 Max Diff. No.: -1.000E+00 Norm: 1.4730E-06
Iteration: 2775 Time: 6.937E+01 Max CFL: 5.449E-01 Max Diff. No.: -1.000E+00 Norm: 1.4548E-06
Iteration: 2800 Time: 7.000E+01 Max CFL: 5.448E-01 Max Diff. No.: -1.000E+00 Norm: 1.4366E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2825 Time: 7.062E+01 Max CFL: 5.448E-01 Max Diff. No.: -1.000E+00 Norm: 1.4185E-06
Iteration: 2850 Time: 7.125E+01 Max CFL: 5.448E-01 Max Diff. No.: -1.000E+00 Norm: 1.4004E-06
Iteration: 2875 Time: 7.187E+01 Max CFL: 5.448E-01 Max Diff. No.: -1.000E+00 Norm: 1.3823E-06
Iteration: 2900 Time: 7.250E+01 Max CFL: 5.448E-01 Max Diff. No.: -1.000E+00 Norm: 1.3642E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 2925 Time: 7.312E+01 Max CFL: 5.448E-01 Max Diff. No.: -1.000E+00 Norm: 1.3462E-06
Iteration: 2950 Time: 7.375E+01 Max CFL: 5.448E-01 Max Diff. No.: -1.000E+00 Norm: 1.3281E-06
Iteration: 2975 Time: 7.437E+01 Max CFL: 5.448E-01 Max Diff. No.: -1.000E+00 Norm: 1.3102E-06
Iteration: 3000 Time: 7.500E+01 Max CFL: 5.448E-01 Max Diff. No.: -1.000E+00 Norm: 1.2923E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3025 Time: 7.563E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.2745E-06
Iteration: 3050 Time: 7.625E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.2569E-06
Iteration: 3075 Time: 7.688E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.2395E-06
Iteration: 3100 Time: 7.750E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.2223E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3125 Time: 7.813E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.2053E-06
Iteration: 3150 Time: 7.875E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.1886E-06
Iteration: 3175 Time: 7.938E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.1721E-06
Iteration: 3200 Time: 8.000E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.1558E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3225 Time: 8.063E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.1398E-06
Iteration: 3250 Time: 8.125E+01 Max CFL: 5.447E-01 Max Diff. No.: -1.000E+00 Norm: 1.1239E-06
Iteration: 3275 Time: 8.188E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 1.1083E-06
Iteration: 3300 Time: 8.250E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 1.0929E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3325 Time: 8.313E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 1.0776E-06
Iteration: 3350 Time: 8.375E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 1.0625E-06
Iteration: 3375 Time: 8.438E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 1.0475E-06
Iteration: 3400 Time: 8.500E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 1.0326E-06
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3425 Time: 8.563E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 1.0180E-06
Iteration: 3450 Time: 8.625E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 1.0035E-06
Iteration: 3475 Time: 8.688E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 9.8934E-07
Iteration: 3500 Time: 8.750E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 9.7539E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3525 Time: 8.813E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 9.6169E-07
Iteration: 3550 Time: 8.875E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 9.4823E-07
Iteration: 3575 Time: 8.938E+01 Max CFL: 5.446E-01 Max Diff. No.: -1.000E+00 Norm: 9.3495E-07
Iteration: 3600 Time: 9.000E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 9.2186E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3625 Time: 9.063E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 9.0893E-07
Iteration: 3650 Time: 9.125E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 8.9616E-07
Iteration: 3675 Time: 9.188E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 8.8354E-07
Iteration: 3700 Time: 9.250E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 8.7105E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3725 Time: 9.313E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 8.5868E-07
Iteration: 3750 Time: 9.375E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 8.4640E-07
Iteration: 3775 Time: 9.438E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 8.3418E-07
Iteration: 3800 Time: 9.500E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 8.2204E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3825 Time: 9.563E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 8.0999E-07
Iteration: 3850 Time: 9.625E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 7.9809E-07
Iteration: 3875 Time: 9.688E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 7.8639E-07
Iteration: 3900 Time: 9.750E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 7.7493E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 3925 Time: 9.813E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 7.6372E-07
Iteration: 3950 Time: 9.875E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 7.5278E-07
Iteration: 3975 Time: 9.938E+01 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 7.4211E-07
Iteration: 4000 Time: 1.000E+02 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 7.3169E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4025 Time: 1.006E+02 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 7.2151E-07
Iteration: 4050 Time: 1.013E+02 Max CFL: 5.445E-01 Max Diff. No.: -1.000E+00 Norm: 7.1157E-07
Iteration: 4075 Time: 1.019E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 7.0184E-07
Iteration: 4100 Time: 1.025E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.9230E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4125 Time: 1.031E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.8291E-07
Iteration: 4150 Time: 1.038E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.7366E-07
Iteration: 4175 Time: 1.044E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.6450E-07
Iteration: 4200 Time: 1.050E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.5543E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4225 Time: 1.056E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.4642E-07
Iteration: 4250 Time: 1.063E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.3745E-07
Iteration: 4275 Time: 1.069E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.2852E-07
Iteration: 4300 Time: 1.075E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.1963E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4325 Time: 1.081E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.1078E-07
Iteration: 4350 Time: 1.088E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 6.0198E-07
Iteration: 4375 Time: 1.094E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.9324E-07
Iteration: 4400 Time: 1.100E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.8458E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4425 Time: 1.106E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.7602E-07
Iteration: 4450 Time: 1.113E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.6758E-07
Iteration: 4475 Time: 1.119E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.5928E-07
Iteration: 4500 Time: 1.125E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.5114E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4525 Time: 1.131E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.4320E-07
Iteration: 4550 Time: 1.138E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.3549E-07
Iteration: 4575 Time: 1.144E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.2803E-07
Iteration: 4600 Time: 1.150E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.2081E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4625 Time: 1.156E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.1383E-07
Iteration: 4650 Time: 1.163E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.0705E-07
Iteration: 4675 Time: 1.169E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 5.0042E-07
Iteration: 4700 Time: 1.175E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 4.9394E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4725 Time: 1.181E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 4.8759E-07
Iteration: 4750 Time: 1.188E+02 Max CFL: 5.444E-01 Max Diff. No.: -1.000E+00 Norm: 4.8136E-07
Iteration: 4775 Time: 1.194E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.7524E-07
Iteration: 4800 Time: 1.200E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.6921E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4825 Time: 1.206E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.6326E-07
Iteration: 4850 Time: 1.213E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.5738E-07
Iteration: 4875 Time: 1.219E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.5159E-07
Iteration: 4900 Time: 1.225E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.4588E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 4925 Time: 1.231E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.4028E-07
Iteration: 4950 Time: 1.238E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.3477E-07
Iteration: 4975 Time: 1.244E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.2935E-07
Iteration: 5000 Time: 1.250E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.2400E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5025 Time: 1.256E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.1870E-07
Iteration: 5050 Time: 1.263E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.1341E-07
Iteration: 5075 Time: 1.269E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.0812E-07
Iteration: 5100 Time: 1.275E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 4.0280E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5125 Time: 1.281E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.9745E-07
Iteration: 5150 Time: 1.288E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.9211E-07
Iteration: 5175 Time: 1.294E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.8681E-07
Iteration: 5200 Time: 1.300E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.8159E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5225 Time: 1.306E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.7648E-07
Iteration: 5250 Time: 1.313E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.7151E-07
Iteration: 5275 Time: 1.319E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.6672E-07
Iteration: 5300 Time: 1.325E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.6209E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5325 Time: 1.331E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.5762E-07
Iteration: 5350 Time: 1.338E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.5327E-07
Iteration: 5375 Time: 1.344E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.4901E-07
Iteration: 5400 Time: 1.350E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.4480E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5425 Time: 1.356E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.4061E-07
Iteration: 5450 Time: 1.363E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.3643E-07
Iteration: 5475 Time: 1.369E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.3226E-07
Iteration: 5500 Time: 1.375E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.2811E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5525 Time: 1.381E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.2402E-07
Iteration: 5550 Time: 1.388E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.2001E-07
Iteration: 5575 Time: 1.394E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.1613E-07
Iteration: 5600 Time: 1.400E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.1238E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5625 Time: 1.406E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.0879E-07
Iteration: 5650 Time: 1.413E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.0534E-07
Iteration: 5675 Time: 1.419E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 3.0200E-07
Iteration: 5700 Time: 1.425E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.9876E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5725 Time: 1.431E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.9556E-07
Iteration: 5750 Time: 1.438E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.9235E-07
Iteration: 5775 Time: 1.444E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.8908E-07
Iteration: 5800 Time: 1.450E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.8572E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5825 Time: 1.456E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.8227E-07
Iteration: 5850 Time: 1.463E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.7877E-07
Iteration: 5875 Time: 1.469E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.7533E-07
Iteration: 5900 Time: 1.475E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.7209E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 5925 Time: 1.481E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.6917E-07
Iteration: 5950 Time: 1.488E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.6661E-07
Iteration: 5975 Time: 1.494E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.6441E-07
Iteration: 6000 Time: 1.500E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.6250E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6025 Time: 1.506E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.6076E-07
Iteration: 6050 Time: 1.513E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.5909E-07
Iteration: 6075 Time: 1.519E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.5738E-07
Iteration: 6100 Time: 1.525E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.5557E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6125 Time: 1.531E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.5360E-07
Iteration: 6150 Time: 1.538E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.5143E-07
Iteration: 6175 Time: 1.544E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.4905E-07
Iteration: 6200 Time: 1.550E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.4645E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6225 Time: 1.556E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.4365E-07
Iteration: 6250 Time: 1.563E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.4067E-07
Iteration: 6275 Time: 1.569E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.3757E-07
Iteration: 6300 Time: 1.575E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.3441E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6325 Time: 1.581E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.3127E-07
Iteration: 6350 Time: 1.588E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.2822E-07
Iteration: 6375 Time: 1.594E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.2533E-07
Iteration: 6400 Time: 1.600E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.2263E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6425 Time: 1.606E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.2012E-07
Iteration: 6450 Time: 1.613E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.1778E-07
Iteration: 6475 Time: 1.619E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.1554E-07
Iteration: 6500 Time: 1.625E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.1334E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6525 Time: 1.631E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.1114E-07
Iteration: 6550 Time: 1.638E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.0894E-07
Iteration: 6575 Time: 1.644E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.0675E-07
Iteration: 6600 Time: 1.650E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.0463E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6625 Time: 1.656E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.0260E-07
Iteration: 6650 Time: 1.663E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 2.0067E-07
Iteration: 6675 Time: 1.669E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 1.9884E-07
Iteration: 6700 Time: 1.675E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 1.9709E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6725 Time: 1.681E+02 Max CFL: 5.443E-01 Max Diff. No.: -1.000E+00 Norm: 1.9538E-07
Iteration: 6750 Time: 1.688E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.9369E-07
Iteration: 6775 Time: 1.694E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.9202E-07
Iteration: 6800 Time: 1.700E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.9039E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6825 Time: 1.706E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8885E-07
Iteration: 6850 Time: 1.713E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8747E-07
Iteration: 6875 Time: 1.719E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8629E-07
Iteration: 6900 Time: 1.725E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8532E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 6925 Time: 1.731E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8448E-07
Iteration: 6950 Time: 1.738E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8368E-07
Iteration: 6975 Time: 1.744E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8279E-07
Iteration: 7000 Time: 1.750E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8173E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7025 Time: 1.756E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8047E-07
Iteration: 7050 Time: 1.763E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7901E-07
Iteration: 7075 Time: 1.769E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7742E-07
Iteration: 7100 Time: 1.775E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7576E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7125 Time: 1.781E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7411E-07
Iteration: 7150 Time: 1.788E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7251E-07
Iteration: 7175 Time: 1.794E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7100E-07
Iteration: 7200 Time: 1.800E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6959E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7225 Time: 1.806E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6827E-07
Iteration: 7250 Time: 1.813E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6700E-07
Iteration: 7275 Time: 1.819E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6578E-07
Iteration: 7300 Time: 1.825E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6456E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7325 Time: 1.831E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6332E-07
Iteration: 7350 Time: 1.838E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6204E-07
Iteration: 7375 Time: 1.844E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6071E-07
Iteration: 7400 Time: 1.850E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5934E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7425 Time: 1.856E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5793E-07
Iteration: 7450 Time: 1.863E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5649E-07
Iteration: 7475 Time: 1.869E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5506E-07
Iteration: 7500 Time: 1.875E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5366E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7525 Time: 1.881E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5230E-07
Iteration: 7550 Time: 1.888E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5101E-07
Iteration: 7575 Time: 1.894E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4978E-07
Iteration: 7600 Time: 1.900E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4861E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7625 Time: 1.906E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4750E-07
Iteration: 7650 Time: 1.913E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4643E-07
Iteration: 7675 Time: 1.919E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4538E-07
Iteration: 7700 Time: 1.925E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4436E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7725 Time: 1.931E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4337E-07
Iteration: 7750 Time: 1.938E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4241E-07
Iteration: 7775 Time: 1.944E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4148E-07
Iteration: 7800 Time: 1.950E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4058E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7825 Time: 1.956E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3971E-07
Iteration: 7850 Time: 1.963E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3884E-07
Iteration: 7875 Time: 1.969E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3798E-07
Iteration: 7900 Time: 1.975E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3712E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 7925 Time: 1.981E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3625E-07
Iteration: 7950 Time: 1.988E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3537E-07
Iteration: 7975 Time: 1.994E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3451E-07
Iteration: 8000 Time: 2.000E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3368E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8025 Time: 2.006E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3288E-07
Iteration: 8050 Time: 2.013E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3213E-07
Iteration: 8075 Time: 2.019E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3141E-07
Iteration: 8100 Time: 2.025E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3070E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8125 Time: 2.031E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3000E-07
Iteration: 8150 Time: 2.038E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2929E-07
Iteration: 8175 Time: 2.044E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2857E-07
Iteration: 8200 Time: 2.050E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2782E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8225 Time: 2.056E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2706E-07
Iteration: 8250 Time: 2.063E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2631E-07
Iteration: 8275 Time: 2.069E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2557E-07
Iteration: 8300 Time: 2.075E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2486E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8325 Time: 2.081E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2417E-07
Iteration: 8350 Time: 2.088E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2351E-07
Iteration: 8375 Time: 2.094E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2285E-07
Iteration: 8400 Time: 2.100E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2220E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8425 Time: 2.106E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2153E-07
Iteration: 8450 Time: 2.113E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2085E-07
Iteration: 8475 Time: 2.119E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2017E-07
Iteration: 8500 Time: 2.125E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1949E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8525 Time: 2.131E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1882E-07
Iteration: 8550 Time: 2.138E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1816E-07
Iteration: 8575 Time: 2.144E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1752E-07
Iteration: 8600 Time: 2.150E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1691E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8625 Time: 2.156E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1630E-07
Iteration: 8650 Time: 2.163E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1570E-07
Iteration: 8675 Time: 2.169E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1510E-07
Iteration: 8700 Time: 2.175E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1449E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8725 Time: 2.181E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1387E-07
Iteration: 8750 Time: 2.188E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1323E-07
Iteration: 8775 Time: 2.194E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1257E-07
Iteration: 8800 Time: 2.200E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1192E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8825 Time: 2.206E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1127E-07
Iteration: 8850 Time: 2.213E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1065E-07
Iteration: 8875 Time: 2.219E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1007E-07
Iteration: 8900 Time: 2.225E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0955E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 8925 Time: 2.231E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0909E-07
Iteration: 8950 Time: 2.238E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0870E-07
Iteration: 8975 Time: 2.244E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0838E-07
Iteration: 9000 Time: 2.250E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0812E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9025 Time: 2.256E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0789E-07
Iteration: 9050 Time: 2.263E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0769E-07
Iteration: 9075 Time: 2.269E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0747E-07
Iteration: 9100 Time: 2.275E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0723E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9125 Time: 2.281E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0694E-07
Iteration: 9150 Time: 2.288E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0657E-07
Iteration: 9175 Time: 2.294E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0612E-07
Iteration: 9200 Time: 2.300E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0557E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9225 Time: 2.306E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0492E-07
Iteration: 9250 Time: 2.313E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0419E-07
Iteration: 9275 Time: 2.319E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0340E-07
Iteration: 9300 Time: 2.325E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0256E-07
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9325 Time: 2.331E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0171E-07
Iteration: 9350 Time: 2.338E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0088E-07
Iteration: 9375 Time: 2.344E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0010E-07
Iteration: 9400 Time: 2.350E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.9397E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9425 Time: 2.356E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.8777E-08
Iteration: 9450 Time: 2.363E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.8240E-08
Iteration: 9475 Time: 2.369E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.7772E-08
Iteration: 9500 Time: 2.375E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.7352E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9525 Time: 2.381E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.6952E-08
Iteration: 9550 Time: 2.388E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.6548E-08
Iteration: 9575 Time: 2.394E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.6124E-08
Iteration: 9600 Time: 2.400E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.5676E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9625 Time: 2.406E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.5208E-08
Iteration: 9650 Time: 2.413E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.4730E-08
Iteration: 9675 Time: 2.419E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.4255E-08
Iteration: 9700 Time: 2.425E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.3792E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9725 Time: 2.431E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.3344E-08
Iteration: 9750 Time: 2.438E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.2913E-08
Iteration: 9775 Time: 2.444E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.2495E-08
Iteration: 9800 Time: 2.450E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.2089E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9825 Time: 2.456E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.1695E-08
Iteration: 9850 Time: 2.463E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.1318E-08
Iteration: 9875 Time: 2.469E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.0964E-08
Iteration: 9900 Time: 2.475E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.0640E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 9925 Time: 2.481E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.0353E-08
Iteration: 9950 Time: 2.488E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.0102E-08
Iteration: 9975 Time: 2.494E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.9883E-08
Iteration: 10000 Time: 2.500E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.9682E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10025 Time: 2.506E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.9484E-08
Iteration: 10050 Time: 2.513E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.9269E-08
Iteration: 10075 Time: 2.519E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.9020E-08
Iteration: 10100 Time: 2.525E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.8722E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10125 Time: 2.531E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.8368E-08
Iteration: 10150 Time: 2.538E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.7961E-08
Iteration: 10175 Time: 2.544E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.7509E-08
Iteration: 10200 Time: 2.550E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.7030E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10225 Time: 2.556E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.6543E-08
Iteration: 10250 Time: 2.563E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.6070E-08
Iteration: 10275 Time: 2.569E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.5630E-08
Iteration: 10300 Time: 2.575E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.5237E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10325 Time: 2.581E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.4895E-08
Iteration: 10350 Time: 2.588E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.4603E-08
Iteration: 10375 Time: 2.594E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.4353E-08
Iteration: 10400 Time: 2.600E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.4131E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10425 Time: 2.606E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.3921E-08
Iteration: 10450 Time: 2.613E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.3708E-08
Iteration: 10475 Time: 2.619E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.3478E-08
Iteration: 10500 Time: 2.625E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.3223E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10525 Time: 2.631E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.2939E-08
Iteration: 10550 Time: 2.638E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.2626E-08
Iteration: 10575 Time: 2.644E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.2290E-08
Iteration: 10600 Time: 2.650E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.1937E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10625 Time: 2.656E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.1576E-08
Iteration: 10650 Time: 2.663E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.1216E-08
Iteration: 10675 Time: 2.669E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.0861E-08
Iteration: 10700 Time: 2.675E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.0515E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10725 Time: 2.681E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.0179E-08
Iteration: 10750 Time: 2.688E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.9852E-08
Iteration: 10775 Time: 2.694E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.9531E-08
Iteration: 10800 Time: 2.700E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.9212E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10825 Time: 2.706E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.8894E-08
Iteration: 10850 Time: 2.713E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.8574E-08
Iteration: 10875 Time: 2.719E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.8252E-08
Iteration: 10900 Time: 2.725E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.7929E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 10925 Time: 2.731E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.7606E-08
Iteration: 10950 Time: 2.738E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.7285E-08
Iteration: 10975 Time: 2.744E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.6965E-08
Iteration: 11000 Time: 2.750E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.6648E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11025 Time: 2.756E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.6330E-08
Iteration: 11050 Time: 2.763E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.6010E-08
Iteration: 11075 Time: 2.769E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.5685E-08
Iteration: 11100 Time: 2.775E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.5356E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11125 Time: 2.781E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.5022E-08
Iteration: 11150 Time: 2.788E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.4687E-08
Iteration: 11175 Time: 2.794E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.4358E-08
Iteration: 11200 Time: 2.800E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.4040E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11225 Time: 2.806E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.3741E-08
Iteration: 11250 Time: 2.813E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.3466E-08
Iteration: 11275 Time: 2.819E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.3218E-08
Iteration: 11300 Time: 2.825E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2996E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11325 Time: 2.831E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2798E-08
Iteration: 11350 Time: 2.838E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2618E-08
Iteration: 11375 Time: 2.844E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2448E-08
Iteration: 11400 Time: 2.850E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2280E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11425 Time: 2.856E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2107E-08
Iteration: 11450 Time: 2.863E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1922E-08
Iteration: 11475 Time: 2.869E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1720E-08
Iteration: 11500 Time: 2.875E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1497E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11525 Time: 2.881E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1255E-08
Iteration: 11550 Time: 2.888E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.0995E-08
Iteration: 11575 Time: 2.894E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.0721E-08
Iteration: 11600 Time: 2.900E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.0441E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11625 Time: 2.906E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.0160E-08
Iteration: 11650 Time: 2.913E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.9883E-08
Iteration: 11675 Time: 2.919E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.9615E-08
Iteration: 11700 Time: 2.925E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.9358E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11725 Time: 2.931E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.9112E-08
Iteration: 11750 Time: 2.938E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.8877E-08
Iteration: 11775 Time: 2.944E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.8652E-08
Iteration: 11800 Time: 2.950E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.8434E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11825 Time: 2.956E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.8224E-08
Iteration: 11850 Time: 2.963E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.8019E-08
Iteration: 11875 Time: 2.969E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.7820E-08
Iteration: 11900 Time: 2.975E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.7628E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 11925 Time: 2.981E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.7442E-08
Iteration: 11950 Time: 2.988E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.7263E-08
Iteration: 11975 Time: 2.994E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.7090E-08
Iteration: 12000 Time: 3.000E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.6922E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12025 Time: 3.006E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.6757E-08
Iteration: 12050 Time: 3.012E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.6592E-08
Iteration: 12075 Time: 3.019E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.6424E-08
Iteration: 12100 Time: 3.025E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.6250E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12125 Time: 3.031E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.6068E-08
Iteration: 12150 Time: 3.037E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.5876E-08
Iteration: 12175 Time: 3.044E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.5672E-08
Iteration: 12200 Time: 3.050E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.5455E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12225 Time: 3.056E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.5227E-08
Iteration: 12250 Time: 3.062E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.4987E-08
Iteration: 12275 Time: 3.069E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.4738E-08
Iteration: 12300 Time: 3.075E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.4482E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12325 Time: 3.081E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.4221E-08
Iteration: 12350 Time: 3.087E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.3960E-08
Iteration: 12375 Time: 3.094E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.3699E-08
Iteration: 12400 Time: 3.100E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.3442E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12425 Time: 3.106E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.3191E-08
Iteration: 12450 Time: 3.112E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.2947E-08
Iteration: 12475 Time: 3.119E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.2711E-08
Iteration: 12500 Time: 3.125E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.2483E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12525 Time: 3.131E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.2263E-08
Iteration: 12550 Time: 3.137E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.2050E-08
Iteration: 12575 Time: 3.144E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1845E-08
Iteration: 12600 Time: 3.150E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1646E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12625 Time: 3.156E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1452E-08
Iteration: 12650 Time: 3.162E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1262E-08
Iteration: 12675 Time: 3.169E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1074E-08
Iteration: 12700 Time: 3.175E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.0889E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12725 Time: 3.181E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.0703E-08
Iteration: 12750 Time: 3.187E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.0517E-08
Iteration: 12775 Time: 3.194E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.0328E-08
Iteration: 12800 Time: 3.200E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.0135E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12825 Time: 3.206E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9938E-08
Iteration: 12850 Time: 3.212E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9736E-08
Iteration: 12875 Time: 3.219E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9527E-08
Iteration: 12900 Time: 3.225E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9312E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 12925 Time: 3.231E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9091E-08
Iteration: 12950 Time: 3.237E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.8863E-08
Iteration: 12975 Time: 3.244E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.8629E-08
Iteration: 13000 Time: 3.250E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.8389E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13025 Time: 3.256E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.8146E-08
Iteration: 13050 Time: 3.262E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.7901E-08
Iteration: 13075 Time: 3.269E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.7658E-08
Iteration: 13100 Time: 3.275E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.7421E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13125 Time: 3.281E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.7196E-08
Iteration: 13150 Time: 3.287E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.6988E-08
Iteration: 13175 Time: 3.294E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.6801E-08
Iteration: 13200 Time: 3.300E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.6638E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13225 Time: 3.306E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.6500E-08
Iteration: 13250 Time: 3.312E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.6383E-08
Iteration: 13275 Time: 3.319E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.6285E-08
Iteration: 13300 Time: 3.325E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.6198E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13325 Time: 3.331E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.6113E-08
Iteration: 13350 Time: 3.337E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.6023E-08
Iteration: 13375 Time: 3.344E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5918E-08
Iteration: 13400 Time: 3.350E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5791E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13425 Time: 3.356E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5635E-08
Iteration: 13450 Time: 3.362E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5447E-08
Iteration: 13475 Time: 3.369E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5226E-08
Iteration: 13500 Time: 3.375E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.4975E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13525 Time: 3.381E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.4700E-08
Iteration: 13550 Time: 3.387E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.4408E-08
Iteration: 13575 Time: 3.394E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.4110E-08
Iteration: 13600 Time: 3.400E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.3814E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13625 Time: 3.406E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.3532E-08
Iteration: 13650 Time: 3.412E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.3269E-08
Iteration: 13675 Time: 3.419E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.3032E-08
Iteration: 13700 Time: 3.425E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.2822E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13725 Time: 3.431E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.2639E-08
Iteration: 13750 Time: 3.437E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.2479E-08
Iteration: 13775 Time: 3.444E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.2338E-08
Iteration: 13800 Time: 3.450E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.2209E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13825 Time: 3.456E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.2086E-08
Iteration: 13850 Time: 3.462E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1962E-08
Iteration: 13875 Time: 3.469E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1833E-08
Iteration: 13900 Time: 3.475E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1695E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 13925 Time: 3.481E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1545E-08
Iteration: 13950 Time: 3.487E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1384E-08
Iteration: 13975 Time: 3.494E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1209E-08
Iteration: 14000 Time: 3.500E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1024E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14025 Time: 3.506E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0829E-08
Iteration: 14050 Time: 3.512E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0627E-08
Iteration: 14075 Time: 3.519E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0419E-08
Iteration: 14100 Time: 3.525E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0208E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14125 Time: 3.531E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.9995E-08
Iteration: 14150 Time: 3.537E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.9781E-08
Iteration: 14175 Time: 3.544E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.9569E-08
Iteration: 14200 Time: 3.550E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.9359E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14225 Time: 3.556E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.9153E-08
Iteration: 14250 Time: 3.562E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.8953E-08
Iteration: 14275 Time: 3.569E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.8762E-08
Iteration: 14300 Time: 3.575E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.8582E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14325 Time: 3.581E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.8416E-08
Iteration: 14350 Time: 3.587E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.8266E-08
Iteration: 14375 Time: 3.594E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.8133E-08
Iteration: 14400 Time: 3.600E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.8020E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14425 Time: 3.606E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7925E-08
Iteration: 14450 Time: 3.612E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7846E-08
Iteration: 14475 Time: 3.619E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7780E-08
Iteration: 14500 Time: 3.625E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7722E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14525 Time: 3.631E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7664E-08
Iteration: 14550 Time: 3.637E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7602E-08
Iteration: 14575 Time: 3.644E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7526E-08
Iteration: 14600 Time: 3.650E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7432E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14625 Time: 3.656E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7314E-08
Iteration: 14650 Time: 3.662E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7167E-08
Iteration: 14675 Time: 3.669E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.6990E-08
Iteration: 14700 Time: 3.675E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.6782E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14725 Time: 3.681E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.6543E-08
Iteration: 14750 Time: 3.687E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.6278E-08
Iteration: 14775 Time: 3.694E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.5992E-08
Iteration: 14800 Time: 3.700E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.5689E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14825 Time: 3.706E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.5379E-08
Iteration: 14850 Time: 3.712E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.5069E-08
Iteration: 14875 Time: 3.719E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.4768E-08
Iteration: 14900 Time: 3.725E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.4484E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 14925 Time: 3.731E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.4222E-08
Iteration: 14950 Time: 3.737E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3987E-08
Iteration: 14975 Time: 3.744E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3782E-08
Iteration: 15000 Time: 3.750E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3606E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15025 Time: 3.756E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3458E-08
Iteration: 15050 Time: 3.762E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3333E-08
Iteration: 15075 Time: 3.769E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3228E-08
Iteration: 15100 Time: 3.775E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3135E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15125 Time: 3.781E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3050E-08
Iteration: 15150 Time: 3.787E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2967E-08
Iteration: 15175 Time: 3.794E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2880E-08
Iteration: 15200 Time: 3.800E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2787E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15225 Time: 3.806E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2682E-08
Iteration: 15250 Time: 3.812E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2564E-08
Iteration: 15275 Time: 3.819E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2432E-08
Iteration: 15300 Time: 3.825E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2285E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15325 Time: 3.831E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2123E-08
Iteration: 15350 Time: 3.837E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1948E-08
Iteration: 15375 Time: 3.844E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1762E-08
Iteration: 15400 Time: 3.850E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1567E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15425 Time: 3.856E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1366E-08
Iteration: 15450 Time: 3.862E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1161E-08
Iteration: 15475 Time: 3.869E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0954E-08
Iteration: 15500 Time: 3.875E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0749E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15525 Time: 3.881E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0547E-08
Iteration: 15550 Time: 3.887E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0350E-08
Iteration: 15575 Time: 3.894E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0159E-08
Iteration: 15600 Time: 3.900E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.9975E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15625 Time: 3.906E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.9798E-08
Iteration: 15650 Time: 3.912E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.9630E-08
Iteration: 15675 Time: 3.919E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.9469E-08
Iteration: 15700 Time: 3.925E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.9315E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15725 Time: 3.931E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.9169E-08
Iteration: 15750 Time: 3.937E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.9027E-08
Iteration: 15775 Time: 3.944E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8890E-08
Iteration: 15800 Time: 3.950E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8756E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15825 Time: 3.956E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8622E-08
Iteration: 15850 Time: 3.962E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8488E-08
Iteration: 15875 Time: 3.969E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8351E-08
Iteration: 15900 Time: 3.975E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8210E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 15925 Time: 3.981E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8064E-08
Iteration: 15950 Time: 3.987E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.7912E-08
Iteration: 15975 Time: 3.994E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.7754E-08
Iteration: 16000 Time: 4.000E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.7591E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16025 Time: 4.006E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.7423E-08
Iteration: 16050 Time: 4.012E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.7251E-08
Iteration: 16075 Time: 4.019E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.7077E-08
Iteration: 16100 Time: 4.025E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.6902E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16125 Time: 4.031E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.6727E-08
Iteration: 16150 Time: 4.037E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.6554E-08
Iteration: 16175 Time: 4.044E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.6383E-08
Iteration: 16200 Time: 4.050E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.6216E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16225 Time: 4.056E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.6052E-08
Iteration: 16250 Time: 4.062E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.5892E-08
Iteration: 16275 Time: 4.069E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.5736E-08
Iteration: 16300 Time: 4.075E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.5583E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16325 Time: 4.081E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.5433E-08
Iteration: 16350 Time: 4.087E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.5283E-08
Iteration: 16375 Time: 4.094E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.5133E-08
Iteration: 16400 Time: 4.100E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.4982E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16425 Time: 4.106E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.4828E-08
Iteration: 16450 Time: 4.112E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.4671E-08
Iteration: 16475 Time: 4.119E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.4511E-08
Iteration: 16500 Time: 4.125E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.4347E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16525 Time: 4.131E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.4181E-08
Iteration: 16550 Time: 4.137E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.4013E-08
Iteration: 16575 Time: 4.144E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.3846E-08
Iteration: 16600 Time: 4.150E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.3679E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16625 Time: 4.156E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.3515E-08
Iteration: 16650 Time: 4.162E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.3354E-08
Iteration: 16675 Time: 4.169E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.3196E-08
Iteration: 16700 Time: 4.175E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.3043E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16725 Time: 4.181E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2894E-08
Iteration: 16750 Time: 4.187E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2748E-08
Iteration: 16775 Time: 4.194E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2604E-08
Iteration: 16800 Time: 4.200E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2462E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16825 Time: 4.206E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2320E-08
Iteration: 16850 Time: 4.212E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2176E-08
Iteration: 16875 Time: 4.219E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2031E-08
Iteration: 16900 Time: 4.225E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.1882E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 16925 Time: 4.231E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.1728E-08
Iteration: 16950 Time: 4.237E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.1570E-08
Iteration: 16975 Time: 4.244E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.1405E-08
Iteration: 17000 Time: 4.250E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.1235E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17025 Time: 4.256E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.1059E-08
Iteration: 17050 Time: 4.262E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.0877E-08
Iteration: 17075 Time: 4.269E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.0692E-08
Iteration: 17100 Time: 4.275E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.0502E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17125 Time: 4.281E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.0311E-08
Iteration: 17150 Time: 4.287E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.0119E-08
Iteration: 17175 Time: 4.294E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.9929E-08
Iteration: 17200 Time: 4.300E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.9741E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17225 Time: 4.306E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.9557E-08
Iteration: 17250 Time: 4.312E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.9379E-08
Iteration: 17275 Time: 4.319E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.9208E-08
Iteration: 17300 Time: 4.325E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.9044E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17325 Time: 4.331E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.8890E-08
Iteration: 17350 Time: 4.337E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.8744E-08
Iteration: 17375 Time: 4.344E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.8606E-08
Iteration: 17400 Time: 4.350E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.8477E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17425 Time: 4.356E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.8353E-08
Iteration: 17450 Time: 4.362E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.8235E-08
Iteration: 17475 Time: 4.369E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.8119E-08
Iteration: 17500 Time: 4.375E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.8003E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17525 Time: 4.381E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.7884E-08
Iteration: 17550 Time: 4.387E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.7760E-08
Iteration: 17575 Time: 4.394E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.7629E-08
Iteration: 17600 Time: 4.400E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.7488E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17625 Time: 4.406E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.7338E-08
Iteration: 17650 Time: 4.412E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.7178E-08
Iteration: 17675 Time: 4.419E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.7010E-08
Iteration: 17700 Time: 4.425E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.6836E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17725 Time: 4.431E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.6658E-08
Iteration: 17750 Time: 4.437E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.6479E-08
Iteration: 17775 Time: 4.444E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.6303E-08
Iteration: 17800 Time: 4.450E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.6131E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17825 Time: 4.456E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.5966E-08
Iteration: 17850 Time: 4.462E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.5811E-08
Iteration: 17875 Time: 4.469E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.5667E-08
Iteration: 17900 Time: 4.475E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.5535E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 17925 Time: 4.481E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.5415E-08
Iteration: 17950 Time: 4.487E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.5307E-08
Iteration: 17975 Time: 4.494E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.5210E-08
Iteration: 18000 Time: 4.500E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.5120E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18025 Time: 4.506E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.5035E-08
Iteration: 18050 Time: 4.512E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.4949E-08
Iteration: 18075 Time: 4.519E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.4858E-08
Iteration: 18100 Time: 4.525E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.4758E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18125 Time: 4.531E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.4645E-08
Iteration: 18150 Time: 4.537E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.4515E-08
Iteration: 18175 Time: 4.544E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.4367E-08
Iteration: 18200 Time: 4.550E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.4201E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18225 Time: 4.556E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.4018E-08
Iteration: 18250 Time: 4.562E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.3819E-08
Iteration: 18275 Time: 4.569E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.3610E-08
Iteration: 18300 Time: 4.575E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.3392E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18325 Time: 4.581E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.3172E-08
Iteration: 18350 Time: 4.587E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.2954E-08
Iteration: 18375 Time: 4.594E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.2744E-08
Iteration: 18400 Time: 4.600E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.2545E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18425 Time: 4.606E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.2362E-08
Iteration: 18450 Time: 4.612E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.2198E-08
Iteration: 18475 Time: 4.619E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.2055E-08
Iteration: 18500 Time: 4.625E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1935E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18525 Time: 4.631E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1835E-08
Iteration: 18550 Time: 4.637E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1755E-08
Iteration: 18575 Time: 4.644E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1690E-08
Iteration: 18600 Time: 4.650E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1636E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18625 Time: 4.656E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1587E-08
Iteration: 18650 Time: 4.662E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1540E-08
Iteration: 18675 Time: 4.669E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1489E-08
Iteration: 18700 Time: 4.675E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1428E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18725 Time: 4.681E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1353E-08
Iteration: 18750 Time: 4.687E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1260E-08
Iteration: 18775 Time: 4.694E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1147E-08
Iteration: 18800 Time: 4.700E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.1011E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18825 Time: 4.706E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.0851E-08
Iteration: 18850 Time: 4.712E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.0668E-08
Iteration: 18875 Time: 4.719E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.0465E-08
Iteration: 18900 Time: 4.725E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.0243E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 18925 Time: 4.731E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.0009E-08
Iteration: 18950 Time: 4.737E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.9768E-08
Iteration: 18975 Time: 4.744E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.9528E-08
Iteration: 19000 Time: 4.750E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.9297E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19025 Time: 4.756E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.9082E-08
Iteration: 19050 Time: 4.762E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8892E-08
Iteration: 19075 Time: 4.769E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8731E-08
Iteration: 19100 Time: 4.775E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8603E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19125 Time: 4.781E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8511E-08
Iteration: 19150 Time: 4.787E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8453E-08
Iteration: 19175 Time: 4.794E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8424E-08
Iteration: 19200 Time: 4.800E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8418E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19225 Time: 4.806E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8428E-08
Iteration: 19250 Time: 4.812E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8442E-08
Iteration: 19275 Time: 4.819E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8452E-08
Iteration: 19300 Time: 4.825E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8448E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19325 Time: 4.831E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8422E-08
Iteration: 19350 Time: 4.837E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8368E-08
Iteration: 19375 Time: 4.844E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8279E-08
Iteration: 19400 Time: 4.850E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.8154E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19425 Time: 4.856E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7992E-08
Iteration: 19450 Time: 4.862E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7793E-08
Iteration: 19475 Time: 4.869E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7562E-08
Iteration: 19500 Time: 4.875E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7304E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19525 Time: 4.881E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.7028E-08
Iteration: 19550 Time: 4.887E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6741E-08
Iteration: 19575 Time: 4.894E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6454E-08
Iteration: 19600 Time: 4.900E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.6178E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19625 Time: 4.906E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5924E-08
Iteration: 19650 Time: 4.912E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5700E-08
Iteration: 19675 Time: 4.919E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5514E-08
Iteration: 19700 Time: 4.925E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5372E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19725 Time: 4.931E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5273E-08
Iteration: 19750 Time: 4.937E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5218E-08
Iteration: 19775 Time: 4.944E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5202E-08
Iteration: 19800 Time: 4.950E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5217E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19825 Time: 4.956E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5256E-08
Iteration: 19850 Time: 4.962E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5307E-08
Iteration: 19875 Time: 4.969E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5361E-08
Iteration: 19900 Time: 4.975E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5408E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 19925 Time: 4.981E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5437E-08
Iteration: 19950 Time: 4.987E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5442E-08
Iteration: 19975 Time: 4.994E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5416E-08
Iteration: 20000 Time: 5.000E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5355E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20025 Time: 5.006E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5256E-08
Iteration: 20050 Time: 5.012E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.5119E-08
Iteration: 20075 Time: 5.019E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4946E-08
Iteration: 20100 Time: 5.025E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4740E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20125 Time: 5.031E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4507E-08
Iteration: 20150 Time: 5.037E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.4253E-08
Iteration: 20175 Time: 5.044E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3987E-08
Iteration: 20200 Time: 5.050E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3717E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20225 Time: 5.056E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3452E-08
Iteration: 20250 Time: 5.062E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.3201E-08
Iteration: 20275 Time: 5.069E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2969E-08
Iteration: 20300 Time: 5.075E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2765E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20325 Time: 5.081E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2592E-08
Iteration: 20350 Time: 5.087E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2453E-08
Iteration: 20375 Time: 5.094E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2350E-08
Iteration: 20400 Time: 5.100E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2279E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20425 Time: 5.106E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2239E-08
Iteration: 20450 Time: 5.112E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2223E-08
Iteration: 20475 Time: 5.119E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2225E-08
Iteration: 20500 Time: 5.125E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2239E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20525 Time: 5.131E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2257E-08
Iteration: 20550 Time: 5.137E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2271E-08
Iteration: 20575 Time: 5.144E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2277E-08
Iteration: 20600 Time: 5.150E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2268E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20625 Time: 5.156E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2242E-08
Iteration: 20650 Time: 5.162E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2194E-08
Iteration: 20675 Time: 5.169E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2125E-08
Iteration: 20700 Time: 5.175E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.2033E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20725 Time: 5.181E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1921E-08
Iteration: 20750 Time: 5.187E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1791E-08
Iteration: 20775 Time: 5.194E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1646E-08
Iteration: 20800 Time: 5.200E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1488E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20825 Time: 5.206E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1323E-08
Iteration: 20850 Time: 5.212E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.1154E-08
Iteration: 20875 Time: 5.219E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0986E-08
Iteration: 20900 Time: 5.225E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0820E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 20925 Time: 5.231E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0662E-08
Iteration: 20950 Time: 5.237E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0512E-08
Iteration: 20975 Time: 5.244E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0374E-08
Iteration: 21000 Time: 5.250E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0247E-08
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21025 Time: 5.256E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0132E-08
Iteration: 21050 Time: 5.262E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 1.0028E-08
Iteration: 21075 Time: 5.269E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.9347E-09
Iteration: 21100 Time: 5.275E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.8504E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21125 Time: 5.281E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.7735E-09
Iteration: 21150 Time: 5.287E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.7022E-09
Iteration: 21175 Time: 5.294E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.6350E-09
Iteration: 21200 Time: 5.300E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.5704E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21225 Time: 5.306E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.5070E-09
Iteration: 21250 Time: 5.312E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.4439E-09
Iteration: 21275 Time: 5.319E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.3805E-09
Iteration: 21300 Time: 5.325E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.3164E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21325 Time: 5.331E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.2514E-09
Iteration: 21350 Time: 5.337E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.1858E-09
Iteration: 21375 Time: 5.344E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.1196E-09
Iteration: 21400 Time: 5.350E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 9.0533E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21425 Time: 5.356E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.9872E-09
Iteration: 21450 Time: 5.362E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.9214E-09
Iteration: 21475 Time: 5.369E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.8561E-09
Iteration: 21500 Time: 5.375E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.7911E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21525 Time: 5.381E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.7262E-09
Iteration: 21550 Time: 5.387E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.6609E-09
Iteration: 21575 Time: 5.394E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.5947E-09
Iteration: 21600 Time: 5.400E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.5270E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21625 Time: 5.406E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.4573E-09
Iteration: 21650 Time: 5.412E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.3850E-09
Iteration: 21675 Time: 5.419E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.3099E-09
Iteration: 21700 Time: 5.425E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.2315E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21725 Time: 5.431E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.1501E-09
Iteration: 21750 Time: 5.437E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 8.0656E-09
Iteration: 21775 Time: 5.444E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.9785E-09
Iteration: 21800 Time: 5.450E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.8895E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21825 Time: 5.456E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.7995E-09
Iteration: 21850 Time: 5.462E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.7098E-09
Iteration: 21875 Time: 5.469E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.6220E-09
Iteration: 21900 Time: 5.475E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.5379E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 21925 Time: 5.481E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.4595E-09
Iteration: 21950 Time: 5.487E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.3885E-09
Iteration: 21975 Time: 5.494E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.3271E-09
Iteration: 22000 Time: 5.500E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2765E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22025 Time: 5.506E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2376E-09
Iteration: 22050 Time: 5.512E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2108E-09
Iteration: 22075 Time: 5.519E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1954E-09
Iteration: 22100 Time: 5.525E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1903E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22125 Time: 5.531E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1930E-09
Iteration: 22150 Time: 5.537E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2009E-09
Iteration: 22175 Time: 5.544E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2104E-09
Iteration: 22200 Time: 5.550E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2179E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22225 Time: 5.556E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2197E-09
Iteration: 22250 Time: 5.562E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.2122E-09
Iteration: 22275 Time: 5.569E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1924E-09
Iteration: 22300 Time: 5.575E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1577E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22325 Time: 5.581E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.1065E-09
Iteration: 22350 Time: 5.587E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 7.0385E-09
Iteration: 22375 Time: 5.594E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.9539E-09
Iteration: 22400 Time: 5.600E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.8543E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22425 Time: 5.606E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.7421E-09
Iteration: 22450 Time: 5.612E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.6209E-09
Iteration: 22475 Time: 5.619E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.4951E-09
Iteration: 22500 Time: 5.625E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.3695E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22525 Time: 5.631E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.2496E-09
Iteration: 22550 Time: 5.637E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1409E-09
Iteration: 22575 Time: 5.644E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.0482E-09
Iteration: 22600 Time: 5.650E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9761E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22625 Time: 5.656E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9272E-09
Iteration: 22650 Time: 5.662E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9029E-09
Iteration: 22675 Time: 5.669E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9026E-09
Iteration: 22700 Time: 5.675E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9234E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22725 Time: 5.681E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9611E-09
Iteration: 22750 Time: 5.687E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.0098E-09
Iteration: 22775 Time: 5.694E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.0630E-09
Iteration: 22800 Time: 5.700E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1137E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22825 Time: 5.706E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1552E-09
Iteration: 22850 Time: 5.712E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1814E-09
Iteration: 22875 Time: 5.719E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1874E-09
Iteration: 22900 Time: 5.725E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1691E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 22925 Time: 5.731E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.1246E-09
Iteration: 22950 Time: 5.737E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 6.0535E-09
Iteration: 22975 Time: 5.744E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9573E-09
Iteration: 23000 Time: 5.750E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.8396E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23025 Time: 5.756E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.7054E-09
Iteration: 23050 Time: 5.762E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5614E-09
Iteration: 23075 Time: 5.769E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.4154E-09
Iteration: 23100 Time: 5.775E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.2760E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23125 Time: 5.781E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1523E-09
Iteration: 23150 Time: 5.787E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0525E-09
Iteration: 23175 Time: 5.794E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.9842E-09
Iteration: 23200 Time: 5.800E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.9525E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23225 Time: 5.806E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.9600E-09
Iteration: 23250 Time: 5.812E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0056E-09
Iteration: 23275 Time: 5.819E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0855E-09
Iteration: 23300 Time: 5.825E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1928E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23325 Time: 5.831E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.3188E-09
Iteration: 23350 Time: 5.837E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.4534E-09
Iteration: 23375 Time: 5.844E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5866E-09
Iteration: 23400 Time: 5.850E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.7089E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23425 Time: 5.856E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.8117E-09
Iteration: 23450 Time: 5.862E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.8881E-09
Iteration: 23475 Time: 5.869E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9324E-09
Iteration: 23500 Time: 5.875E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9406E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23525 Time: 5.881E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.9105E-09
Iteration: 23550 Time: 5.887E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.8414E-09
Iteration: 23575 Time: 5.894E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.7343E-09
Iteration: 23600 Time: 5.900E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5921E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23625 Time: 5.906E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.4196E-09
Iteration: 23650 Time: 5.912E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.2235E-09
Iteration: 23675 Time: 5.919E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0127E-09
Iteration: 23700 Time: 5.925E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7979E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23725 Time: 5.931E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.5916E-09
Iteration: 23750 Time: 5.937E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.4077E-09
Iteration: 23775 Time: 5.944E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2602E-09
Iteration: 23800 Time: 5.950E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1618E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23825 Time: 5.956E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1208E-09
Iteration: 23850 Time: 5.962E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1406E-09
Iteration: 23875 Time: 5.969E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.2176E-09
Iteration: 23900 Time: 5.975E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3428E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 23925 Time: 5.981E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.5032E-09
Iteration: 23950 Time: 5.987E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.6845E-09
Iteration: 23975 Time: 5.994E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.8723E-09
Iteration: 24000 Time: 6.000E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0536E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24025 Time: 6.006E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.2172E-09
Iteration: 24050 Time: 6.012E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.3538E-09
Iteration: 24075 Time: 6.019E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.4561E-09
Iteration: 24100 Time: 6.025E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5190E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24125 Time: 6.031E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5391E-09
Iteration: 24150 Time: 6.037E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.5148E-09
Iteration: 24175 Time: 6.044E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.4464E-09
Iteration: 24200 Time: 6.050E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.3358E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24225 Time: 6.056E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.1864E-09
Iteration: 24250 Time: 6.062E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 5.0035E-09
Iteration: 24275 Time: 6.069E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.7934E-09
Iteration: 24300 Time: 6.075E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.5641E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24325 Time: 6.081E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.3246E-09
Iteration: 24350 Time: 6.087E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0855E-09
Iteration: 24375 Time: 6.094E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8579E-09
Iteration: 24400 Time: 6.100E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.6536E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24425 Time: 6.106E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.4840E-09
Iteration: 24450 Time: 6.112E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.3590E-09
Iteration: 24475 Time: 6.119E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2851E-09
Iteration: 24500 Time: 6.125E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2645E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24525 Time: 6.131E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.2937E-09
Iteration: 24550 Time: 6.137E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.3647E-09
Iteration: 24575 Time: 6.144E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.4666E-09
Iteration: 24600 Time: 6.150E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.5870E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24625 Time: 6.156E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.7139E-09
Iteration: 24650 Time: 6.162E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8364E-09
Iteration: 24675 Time: 6.169E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.9453E-09
Iteration: 24700 Time: 6.175E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0334E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24725 Time: 6.181E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0954E-09
Iteration: 24750 Time: 6.187E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1276E-09
Iteration: 24775 Time: 6.194E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.1281E-09
Iteration: 24800 Time: 6.200E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0961E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24825 Time: 6.206E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 4.0323E-09
Iteration: 24850 Time: 6.212E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.9386E-09
Iteration: 24875 Time: 6.219E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.8180E-09
Iteration: 24900 Time: 6.225E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.6745E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Iteration: 24925 Time: 6.231E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.5129E-09
Iteration: 24950 Time: 6.237E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.3394E-09
Iteration: 24975 Time: 6.244E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 3.1609E-09
Iteration: 25000 Time: 6.250E+02 Max CFL: 5.442E-01 Max Diff. No.: -1.000E+00 Norm: 2.9854E-09
Writing immersed body surface data file surface.dat.
Writing solution file op.bin.
Completed time integration (Final time: 625.000000).
Solver runtime (in seconds): 9.5139256449999993E+03
Total runtime (in seconds): 9.5150037489999995E+03
Deallocating arrays.
Finished.