WIP: Pull Request for a complete Solver package #1
@ -32,7 +32,7 @@ jmax 50 # number of interior cells in y-direction
|
||||
# Time Data:
|
||||
# ---------
|
||||
|
||||
te 60.0 # final time
|
||||
te 100.0 # final time
|
||||
dt 0.02 # time stepsize
|
||||
tau 0.5 # safety factor for time stepsize control (<0 constant delt)
|
||||
|
||||
@ -48,14 +48,25 @@ gamma 0.9 # upwind differencing factor gamma
|
||||
# Particle Tracing Data:
|
||||
# -----------------------
|
||||
|
||||
numberOfParticles 30
|
||||
numberOfParticles 60
|
||||
startTime 10
|
||||
injectTimePeriod 2.0
|
||||
writeTimePeriod 2.0
|
||||
writeTimePeriod 1.0
|
||||
|
||||
x1 1.0
|
||||
y1 0.0
|
||||
x2 1.0
|
||||
y2 4.0
|
||||
|
||||
# Obstacle Geometry Data:
|
||||
# -----------------------
|
||||
# Shape 0 disable, 1 Rectangle/Square, 2 Circle
|
||||
|
||||
shape 1
|
||||
xCenter 7.0
|
||||
yCenter 2.0
|
||||
xRectLength 3.0
|
||||
yRectLength 1.0
|
||||
circleRadius 1.0
|
||||
|
||||
#===============================================================================
|
||||
|
@ -32,7 +32,7 @@ jmax 40 # number of interior cells in y-direction
|
||||
# Time Data:
|
||||
# ---------
|
||||
|
||||
te 100.0 # final time
|
||||
te 60.0 # final time
|
||||
dt 0.02 # time stepsize
|
||||
tau 0.5 # safety factor for time stepsize control (<0 constant delt)
|
||||
|
||||
@ -51,10 +51,22 @@ gamma 0.9 # upwind differencing factor gamma
|
||||
numberOfParticles 30
|
||||
startTime 0
|
||||
injectTimePeriod 2.0
|
||||
writeTimePeriod 0.5
|
||||
writeTimePeriod 0.2
|
||||
|
||||
x1 0.1
|
||||
y1 0.9
|
||||
x2 0.9
|
||||
y2 0.9
|
||||
|
||||
|
||||
# Obstacle Geometry Data:
|
||||
# -----------------------
|
||||
# Shape 0 disable, 1 Rectangle/Square, 2 Circle
|
||||
|
||||
shape 1
|
||||
xCenter 0.5
|
||||
yCenter 0.5
|
||||
xRectLength 0.5
|
||||
yRectLength 0.5
|
||||
circleRadius 0.5
|
||||
#===============================================================================
|
||||
|
BIN
BasicSolver/2D-seq/p.png
Normal file
BIN
BasicSolver/2D-seq/p.png
Normal file
Binary file not shown.
After Width: | Height: | Size: 30 KiB |
File diff suppressed because it is too large
Load Diff
@ -57,6 +57,10 @@ int main (int argc, char** argv)
|
||||
|
||||
void (*solver_generic[])() = {solve, solveRB, solveRBA};
|
||||
|
||||
//print(&solver, solver.s);
|
||||
|
||||
//exit(0);
|
||||
|
||||
S = getTimeStamp();
|
||||
|
||||
while (t <= te)
|
||||
@ -71,7 +75,7 @@ int main (int argc, char** argv)
|
||||
adaptUV(&solver);
|
||||
|
||||
/* Added function for particle tracing. Will inject and advance particles as per timePeriod */
|
||||
trace(&particletracer, solver.u, solver.v, t);
|
||||
//trace(&particletracer, solver.u, solver.v, t);
|
||||
|
||||
t += solver.dt;
|
||||
nt++;
|
||||
@ -84,6 +88,9 @@ int main (int argc, char** argv)
|
||||
#endif
|
||||
}
|
||||
printf("Total particles : %d\n", particletracer.totalParticles);
|
||||
|
||||
//print(&solver, solver.p);
|
||||
|
||||
E = getTimeStamp();
|
||||
stopProgress();
|
||||
|
||||
|
@ -90,6 +90,15 @@ void readParameter(Parameter* param, const char* filename)
|
||||
PARSE_REAL(y1);
|
||||
PARSE_REAL(x2);
|
||||
PARSE_REAL(y2);
|
||||
|
||||
/* Added obstacle geometry parameters */
|
||||
PARSE_INT(shape);
|
||||
PARSE_REAL(xCenter);
|
||||
PARSE_REAL(yCenter);
|
||||
PARSE_REAL(xRectLength);
|
||||
PARSE_REAL(yRectLength);
|
||||
PARSE_REAL(circleRadius);
|
||||
|
||||
}
|
||||
}
|
||||
|
||||
|
@ -23,6 +23,10 @@ typedef struct {
|
||||
double startTime, injectTimePeriod, writeTimePeriod;
|
||||
|
||||
double x1, y1, x2, y2;
|
||||
|
||||
int shape;
|
||||
double xCenter, yCenter, xRectLength, yRectLength, circleRadius;
|
||||
|
||||
} Parameter;
|
||||
|
||||
void initParameter(Parameter*);
|
||||
|
@ -205,7 +205,6 @@ void trace(ParticleTracer* particletracer, double* u, double* v, double time)
|
||||
if( (time - particletracer->lastInjectTime) >= particletracer->injectTimePeriod)
|
||||
{
|
||||
injectParticles(particletracer);
|
||||
printf("Rank : %d particles after particles injected !", particletracer->rank);
|
||||
particletracer->lastInjectTime = time;
|
||||
}
|
||||
if( (time - particletracer->lastWriteTime) >= particletracer->writeTimePeriod)
|
||||
|
@ -43,6 +43,6 @@ void freeParticles(ParticleTracer*);
|
||||
void writeParticles(ParticleTracer*);
|
||||
void printParticleTracerParameters(ParticleTracer*);
|
||||
void printParticles(ParticleTracer*);
|
||||
void trace(ParticleTracer*, Solver*, double* , double* , double );
|
||||
void trace(ParticleTracer*, double* , double* , double );
|
||||
void compress(ParticleTracer* );
|
||||
#endif
|
@ -20,9 +20,16 @@
|
||||
#define G(i, j) g[(j) * (imax + 2) + (i)]
|
||||
#define U(i, j) u[(j) * (imax + 2) + (i)]
|
||||
#define V(i, j) v[(j) * (imax + 2) + (i)]
|
||||
#define S(i, j) s[(j) * (imax + 2) + (i)]
|
||||
#define RHS(i, j) rhs[(j) * (imax + 2) + (i)]
|
||||
|
||||
static void print(Solver* solver, double* grid)
|
||||
static double distance(i, j, iCenter, jCenter)
|
||||
{
|
||||
return sqrt(pow(iCenter - i, 2)
|
||||
+ pow(jCenter - j, 2) * 1.0);
|
||||
}
|
||||
|
||||
void print(Solver* solver, double* grid)
|
||||
{
|
||||
int imax = solver->imax;
|
||||
|
||||
@ -91,6 +98,7 @@ void initSolver(Solver* solver, Parameter* params)
|
||||
size_t size = (imax + 2) * (jmax + 2) * sizeof(double);
|
||||
solver->u = allocate(64, size);
|
||||
solver->v = allocate(64, size);
|
||||
solver->s = allocate(64, size);
|
||||
solver->p = allocate(64, size);
|
||||
solver->rhs = allocate(64, size);
|
||||
solver->f = allocate(64, size);
|
||||
@ -103,12 +111,71 @@ void initSolver(Solver* solver, Parameter* params)
|
||||
solver->rhs[i] = 0.0;
|
||||
solver->f[i] = 0.0;
|
||||
solver->g[i] = 0.0;
|
||||
solver->s[i] = 1.0;
|
||||
}
|
||||
|
||||
double dx = solver->dx;
|
||||
double dy = solver->dy;
|
||||
double invSqrSum = 1.0 / (dx * dx) + 1.0 / (dy * dy);
|
||||
solver->dtBound = 0.5 * solver->re * 1.0 / invSqrSum;
|
||||
|
||||
int iCenter = 0, jCenter = 0, iRectLength = 0, jRectLength = 0, radius = 0;
|
||||
|
||||
double* s = solver->s;
|
||||
|
||||
switch(params->shape)
|
||||
{
|
||||
case NOSHAPE:
|
||||
break;
|
||||
case RECT:
|
||||
iCenter = params->xCenter/dx;
|
||||
jCenter = params->yCenter/dy;
|
||||
iRectLength = params->xRectLength/dx;
|
||||
jRectLength = params->yRectLength/dy;
|
||||
|
||||
int i1 = iCenter - iRectLength/2;
|
||||
int i2 = iCenter + iRectLength/2;
|
||||
int j1 = jCenter - jRectLength/2;
|
||||
int j2 = jCenter + jRectLength/2;
|
||||
|
||||
printf("xCenter : %f, yCenter : %f, iCenter : %d, jCenter : %d\n", params->xCenter, params->yCenter, iCenter, jCenter);
|
||||
printf("xRectLength : %f, yRectLength : %f, dx : %f, dy : %f\n", params->xRectLength, params->yRectLength, dx, dy);
|
||||
printf("iRectLength : %d, jRectLength : %d, i1 : %d, i2 : %d, j1 : %d, j2 : %d\n", iRectLength, jRectLength, i1, i2, j1, j2);
|
||||
|
||||
for (int j = 1; j < jmax + 1; j++)
|
||||
{
|
||||
for (int i = 1; i < imax + 1; i++)
|
||||
{
|
||||
if(i1 <= i && i <= i2 && j1 <= j && j <= j2)
|
||||
{
|
||||
// if(i == i1 || i == i2 || j == j1 || j == j2) S(i, j) = 2.0;
|
||||
S(i, j) = 0.0;
|
||||
}
|
||||
}
|
||||
}
|
||||
|
||||
break;
|
||||
case CIRCLE:
|
||||
iCenter = params->xCenter/dx;
|
||||
jCenter = params->yCenter/dy;
|
||||
radius = params->circleRadius/dx; // have to change the logic to get max out of both the dx and dy
|
||||
|
||||
for (int j = 1; j < jmax + 1; j++)
|
||||
{
|
||||
for (int i = 1; i < imax + 1; i++)
|
||||
{
|
||||
if(distance(i, j, iCenter, jCenter) <= radius)
|
||||
{
|
||||
S(i, j) = 0.0;
|
||||
}
|
||||
}
|
||||
}
|
||||
|
||||
break;
|
||||
default:
|
||||
break;
|
||||
}
|
||||
|
||||
#ifdef VERBOSE
|
||||
printConfig(solver);
|
||||
#endif
|
||||
@ -199,10 +266,12 @@ void solveRB(Solver* solver)
|
||||
double idy2 = 1.0 / dy2;
|
||||
double factor = solver->omega * 0.5 * (dx2 * dy2) / (dx2 + dy2);
|
||||
double* p = solver->p;
|
||||
double* s = solver->s;
|
||||
double* rhs = solver->rhs;
|
||||
double epssq = eps * eps;
|
||||
int it = 0;
|
||||
double res = 1.0;
|
||||
double val = 1.0;
|
||||
int pass, jsw, isw;
|
||||
|
||||
while ((res >= epssq) && (it < itermax)) {
|
||||
@ -214,12 +283,16 @@ void solveRB(Solver* solver)
|
||||
|
||||
for (int j = 1; j < jmax + 1; j++) {
|
||||
for (int i = isw; i < imax + 1; i += 2) {
|
||||
|
||||
// val = S(i+1, j) + S(i-1, j) + S(i, j+1) + S(i, j-1);
|
||||
// if(val == 0 || S(i,j) == 0)
|
||||
// {
|
||||
// continue;
|
||||
// }
|
||||
double r = RHS(i, j) -
|
||||
((P(i + 1, j) - 2.0 * P(i, j) + P(i - 1, j)) * idx2 +
|
||||
(P(i, j + 1) - 2.0 * P(i, j) + P(i, j - 1)) * idy2);
|
||||
|
||||
P(i, j) -= (factor * r);
|
||||
P(i, j) -= (factor * r );
|
||||
res += (r * r);
|
||||
}
|
||||
isw = 3 - isw;
|
||||
@ -568,13 +641,31 @@ void adaptUV(Solver* solver)
|
||||
double* p = solver->p;
|
||||
double* u = solver->u;
|
||||
double* v = solver->v;
|
||||
double* s = solver->s;
|
||||
double* f = solver->f;
|
||||
double* g = solver->g;
|
||||
double factorX = solver->dt / solver->dx;
|
||||
double factorY = solver->dt / solver->dy;
|
||||
|
||||
for (int j = 1; j < jmax + 1; j++) {
|
||||
for (int i = 1; i < imax + 1; i++) {
|
||||
double val = 0;
|
||||
|
||||
for (int j = 1; j < jmax + 1; j++)
|
||||
{
|
||||
for (int i = 1; i < imax + 1; i++)
|
||||
{
|
||||
val = S(i+1, j) + S(i-1, j) + S(i, j+1) + S(i, j-1);
|
||||
if(S(i,j) == 0 && val == 0)
|
||||
{
|
||||
U(i, j) = 0;
|
||||
V(i, j) = 0;
|
||||
continue;
|
||||
}
|
||||
// else if(S(i,j) == 2.0)
|
||||
// {
|
||||
// U(i, j) = -U(i, j);
|
||||
// V(i, j) = -V(i, j);
|
||||
// continue;
|
||||
// }
|
||||
U(i, j) = F(i, j) - (P(i + 1, j) - P(i, j)) * factorX;
|
||||
V(i, j) = G(i, j) - (P(i, j + 1) - P(i, j)) * factorY;
|
||||
}
|
||||
|
@ -9,6 +9,8 @@
|
||||
#include "parameter.h"
|
||||
|
||||
enum BC { NOSLIP = 1, SLIP, OUTFLOW, PERIODIC };
|
||||
/// @brief
|
||||
enum SHAPE { NOSHAPE = 0, RECT, CIRCLE };
|
||||
|
||||
typedef struct {
|
||||
/* geometry and grid information */
|
||||
@ -18,7 +20,7 @@ typedef struct {
|
||||
/* arrays */
|
||||
double *p, *rhs;
|
||||
double *f, *g;
|
||||
double *u, *v;
|
||||
double *u, *v, *s;
|
||||
/* parameters */
|
||||
double eps, omega, rho;
|
||||
double re, tau, gamma;
|
||||
@ -43,4 +45,5 @@ extern void setSpecialBoundaryCondition(Solver*);
|
||||
extern void computeFG(Solver*);
|
||||
extern void adaptUV(Solver*);
|
||||
extern void writeResult(Solver*);
|
||||
extern void print(Solver*, double*);
|
||||
#endif
|
||||
|
@ -4,6 +4,8 @@
|
||||
* Use of this source code is governed by a MIT-style
|
||||
* license that can be found in the LICENSE file.
|
||||
*/
|
||||
#include <math.h>
|
||||
|
||||
#ifndef __UTIL_H_
|
||||
#define __UTIL_H_
|
||||
#define HLINE \
|
||||
|
File diff suppressed because it is too large
Load Diff
Binary file not shown.
After Width: | Height: | Size: 79 KiB |
@ -3,7 +3,7 @@ set term gif animate delay 50
|
||||
set output "trace.gif"
|
||||
set xrange [0:30]
|
||||
set yrange [0:4]
|
||||
do for [ts=0:198] {
|
||||
do for [ts=0:200] {
|
||||
plot "particles_".ts.".dat" with points pointtype 7
|
||||
}
|
||||
unset output
|
||||
|
BIN
BasicSolver/2D-seq/vis_files/trace.gif
Normal file
BIN
BasicSolver/2D-seq/vis_files/trace.gif
Normal file
Binary file not shown.
After Width: | Height: | Size: 796 KiB |
12
BasicSolver/2D-seq/vtk_files/particles0.vtk
Normal file
12
BasicSolver/2D-seq/vtk_files/particles0.vtk
Normal file
@ -0,0 +1,12 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
0
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 0 float
|
||||
CELLS 0 0
|
||||
CELL_TYPES 0
|
189
BasicSolver/2D-seq/vtk_files/particles1.vtk
Normal file
189
BasicSolver/2D-seq/vtk_files/particles1.vtk
Normal file
@ -0,0 +1,189 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
1
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 59 float
|
||||
1.00 4.00 0.0
|
||||
1.00 3.93 0.0
|
||||
1.00 3.86 0.0
|
||||
1.00 3.80 0.0
|
||||
1.01 3.73 0.0
|
||||
1.01 3.66 0.0
|
||||
1.01 3.59 0.0
|
||||
1.01 3.53 0.0
|
||||
1.01 3.46 0.0
|
||||
1.01 3.39 0.0
|
||||
1.01 3.32 0.0
|
||||
1.01 3.25 0.0
|
||||
1.01 3.19 0.0
|
||||
1.01 3.12 0.0
|
||||
1.01 3.05 0.0
|
||||
1.02 2.98 0.0
|
||||
1.02 2.92 0.0
|
||||
1.02 2.85 0.0
|
||||
1.02 2.78 0.0
|
||||
1.02 2.71 0.0
|
||||
1.02 2.64 0.0
|
||||
1.02 2.58 0.0
|
||||
1.02 2.51 0.0
|
||||
1.02 2.44 0.0
|
||||
1.02 2.37 0.0
|
||||
1.02 2.31 0.0
|
||||
1.02 2.24 0.0
|
||||
1.02 2.17 0.0
|
||||
1.02 2.10 0.0
|
||||
1.02 2.03 0.0
|
||||
1.02 1.97 0.0
|
||||
1.02 1.90 0.0
|
||||
1.02 1.83 0.0
|
||||
1.02 1.76 0.0
|
||||
1.02 1.69 0.0
|
||||
1.02 1.63 0.0
|
||||
1.02 1.56 0.0
|
||||
1.02 1.49 0.0
|
||||
1.02 1.42 0.0
|
||||
1.02 1.36 0.0
|
||||
1.02 1.29 0.0
|
||||
1.02 1.22 0.0
|
||||
1.02 1.15 0.0
|
||||
1.02 1.08 0.0
|
||||
1.02 1.02 0.0
|
||||
1.01 0.95 0.0
|
||||
1.01 0.88 0.0
|
||||
1.01 0.81 0.0
|
||||
1.01 0.75 0.0
|
||||
1.01 0.68 0.0
|
||||
1.01 0.61 0.0
|
||||
1.01 0.54 0.0
|
||||
1.01 0.47 0.0
|
||||
1.01 0.41 0.0
|
||||
1.01 0.34 0.0
|
||||
1.01 0.27 0.0
|
||||
1.00 0.20 0.0
|
||||
1.00 0.14 0.0
|
||||
1.00 0.07 0.0
|
||||
CELLS 59 118
|
||||
1 0
|
||||
1 1
|
||||
1 2
|
||||
1 3
|
||||
1 4
|
||||
1 5
|
||||
1 6
|
||||
1 7
|
||||
1 8
|
||||
1 9
|
||||
1 10
|
||||
1 11
|
||||
1 12
|
||||
1 13
|
||||
1 14
|
||||
1 15
|
||||
1 16
|
||||
1 17
|
||||
1 18
|
||||
1 19
|
||||
1 20
|
||||
1 21
|
||||
1 22
|
||||
1 23
|
||||
1 24
|
||||
1 25
|
||||
1 26
|
||||
1 27
|
||||
1 28
|
||||
1 29
|
||||
1 30
|
||||
1 31
|
||||
1 32
|
||||
1 33
|
||||
1 34
|
||||
1 35
|
||||
1 36
|
||||
1 37
|
||||
1 38
|
||||
1 39
|
||||
1 40
|
||||
1 41
|
||||
1 42
|
||||
1 43
|
||||
1 44
|
||||
1 45
|
||||
1 46
|
||||
1 47
|
||||
1 48
|
||||
1 49
|
||||
1 50
|
||||
1 51
|
||||
1 52
|
||||
1 53
|
||||
1 54
|
||||
1 55
|
||||
1 56
|
||||
1 57
|
||||
1 58
|
||||
CELL_TYPES 59
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
909
BasicSolver/2D-seq/vtk_files/particles10.vtk
Normal file
909
BasicSolver/2D-seq/vtk_files/particles10.vtk
Normal file
@ -0,0 +1,909 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
10
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 299 float
|
||||
1.00 4.00 0.0
|
||||
1.24 3.94 0.0
|
||||
1.49 3.87 0.0
|
||||
1.73 3.80 0.0
|
||||
1.96 3.73 0.0
|
||||
2.17 3.67 0.0
|
||||
2.38 3.60 0.0
|
||||
2.58 3.54 0.0
|
||||
2.78 3.48 0.0
|
||||
2.96 3.42 0.0
|
||||
3.13 3.36 0.0
|
||||
3.29 3.30 0.0
|
||||
3.44 3.24 0.0
|
||||
3.58 3.18 0.0
|
||||
3.72 3.12 0.0
|
||||
3.84 3.06 0.0
|
||||
3.95 3.01 0.0
|
||||
4.05 2.95 0.0
|
||||
4.14 2.89 0.0
|
||||
4.23 2.83 0.0
|
||||
4.30 2.77 0.0
|
||||
4.36 2.71 0.0
|
||||
4.41 2.64 0.0
|
||||
4.46 2.58 0.0
|
||||
4.49 2.50 0.0
|
||||
4.51 2.43 0.0
|
||||
4.53 2.34 0.0
|
||||
4.54 2.26 0.0
|
||||
4.55 2.17 0.0
|
||||
4.55 2.07 0.0
|
||||
4.55 1.98 0.0
|
||||
4.55 1.89 0.0
|
||||
4.54 1.79 0.0
|
||||
4.52 1.71 0.0
|
||||
4.50 1.62 0.0
|
||||
4.47 1.54 0.0
|
||||
4.44 1.46 0.0
|
||||
4.40 1.39 0.0
|
||||
4.34 1.32 0.0
|
||||
4.28 1.26 0.0
|
||||
4.21 1.20 0.0
|
||||
4.12 1.14 0.0
|
||||
4.03 1.08 0.0
|
||||
3.93 1.02 0.0
|
||||
3.82 0.96 0.0
|
||||
3.69 0.90 0.0
|
||||
3.56 0.84 0.0
|
||||
3.42 0.78 0.0
|
||||
3.27 0.72 0.0
|
||||
3.10 0.66 0.0
|
||||
2.93 0.59 0.0
|
||||
2.75 0.53 0.0
|
||||
2.56 0.47 0.0
|
||||
2.36 0.40 0.0
|
||||
2.15 0.33 0.0
|
||||
1.94 0.27 0.0
|
||||
1.71 0.20 0.0
|
||||
1.48 0.13 0.0
|
||||
1.23 0.07 0.0
|
||||
1.18 0.07 0.0
|
||||
1.00 4.00 0.0
|
||||
1.19 3.93 0.0
|
||||
1.38 3.87 0.0
|
||||
1.57 3.80 0.0
|
||||
1.75 3.73 0.0
|
||||
1.92 3.67 0.0
|
||||
2.08 3.60 0.0
|
||||
2.24 3.54 0.0
|
||||
2.39 3.47 0.0
|
||||
2.53 3.41 0.0
|
||||
2.67 3.34 0.0
|
||||
2.80 3.28 0.0
|
||||
2.92 3.21 0.0
|
||||
3.03 3.15 0.0
|
||||
3.14 3.08 0.0
|
||||
3.23 3.02 0.0
|
||||
3.33 2.96 0.0
|
||||
3.41 2.89 0.0
|
||||
3.49 2.83 0.0
|
||||
3.56 2.76 0.0
|
||||
3.62 2.69 0.0
|
||||
3.67 2.63 0.0
|
||||
3.72 2.56 0.0
|
||||
3.76 2.49 0.0
|
||||
3.80 2.42 0.0
|
||||
3.83 2.35 0.0
|
||||
3.85 2.27 0.0
|
||||
3.87 2.20 0.0
|
||||
3.88 2.13 0.0
|
||||
3.88 2.05 0.0
|
||||
3.88 1.98 0.0
|
||||
3.88 1.90 0.0
|
||||
3.86 1.83 0.0
|
||||
3.85 1.75 0.0
|
||||
3.82 1.68 0.0
|
||||
3.79 1.61 0.0
|
||||
3.76 1.54 0.0
|
||||
3.71 1.46 0.0
|
||||
3.66 1.40 0.0
|
||||
3.61 1.33 0.0
|
||||
3.54 1.26 0.0
|
||||
3.47 1.19 0.0
|
||||
3.40 1.13 0.0
|
||||
3.31 1.06 0.0
|
||||
3.22 0.99 0.0
|
||||
3.12 0.93 0.0
|
||||
3.01 0.86 0.0
|
||||
2.90 0.80 0.0
|
||||
2.78 0.73 0.0
|
||||
2.65 0.67 0.0
|
||||
2.52 0.60 0.0
|
||||
2.37 0.54 0.0
|
||||
2.22 0.47 0.0
|
||||
2.07 0.40 0.0
|
||||
1.90 0.34 0.0
|
||||
1.74 0.27 0.0
|
||||
1.56 0.20 0.0
|
||||
1.37 0.13 0.0
|
||||
1.18 0.07 0.0
|
||||
1.00 0.00 0.0
|
||||
1.00 4.00 0.0
|
||||
1.14 3.93 0.0
|
||||
1.28 3.87 0.0
|
||||
1.41 3.80 0.0
|
||||
1.54 3.73 0.0
|
||||
1.67 3.67 0.0
|
||||
1.79 3.60 0.0
|
||||
1.90 3.53 0.0
|
||||
2.01 3.47 0.0
|
||||
2.11 3.40 0.0
|
||||
2.21 3.33 0.0
|
||||
2.30 3.27 0.0
|
||||
2.39 3.20 0.0
|
||||
2.47 3.13 0.0
|
||||
2.55 3.07 0.0
|
||||
2.62 3.00 0.0
|
||||
2.69 2.93 0.0
|
||||
2.75 2.87 0.0
|
||||
2.81 2.80 0.0
|
||||
2.86 2.73 0.0
|
||||
2.91 2.66 0.0
|
||||
2.95 2.60 0.0
|
||||
2.99 2.53 0.0
|
||||
3.02 2.46 0.0
|
||||
3.05 2.39 0.0
|
||||
3.08 2.32 0.0
|
||||
3.09 2.25 0.0
|
||||
3.11 2.18 0.0
|
||||
3.12 2.11 0.0
|
||||
3.12 2.04 0.0
|
||||
3.12 1.97 0.0
|
||||
3.12 1.90 0.0
|
||||
3.11 1.83 0.0
|
||||
3.09 1.76 0.0
|
||||
3.07 1.69 0.0
|
||||
3.05 1.62 0.0
|
||||
3.02 1.56 0.0
|
||||
2.99 1.49 0.0
|
||||
2.95 1.42 0.0
|
||||
2.90 1.35 0.0
|
||||
2.86 1.28 0.0
|
||||
2.80 1.21 0.0
|
||||
2.75 1.14 0.0
|
||||
2.68 1.08 0.0
|
||||
2.61 1.01 0.0
|
||||
2.54 0.94 0.0
|
||||
2.46 0.88 0.0
|
||||
2.38 0.81 0.0
|
||||
2.29 0.74 0.0
|
||||
2.20 0.67 0.0
|
||||
2.10 0.61 0.0
|
||||
2.00 0.54 0.0
|
||||
1.89 0.47 0.0
|
||||
1.77 0.40 0.0
|
||||
1.66 0.34 0.0
|
||||
1.53 0.27 0.0
|
||||
1.41 0.20 0.0
|
||||
1.27 0.13 0.0
|
||||
1.13 0.07 0.0
|
||||
1.00 0.00 0.0
|
||||
1.00 4.00 0.0
|
||||
1.08 3.93 0.0
|
||||
1.17 3.87 0.0
|
||||
1.26 3.80 0.0
|
||||
1.34 3.73 0.0
|
||||
1.41 3.66 0.0
|
||||
1.49 3.60 0.0
|
||||
1.56 3.53 0.0
|
||||
1.63 3.46 0.0
|
||||
1.69 3.39 0.0
|
||||
1.75 3.33 0.0
|
||||
1.81 3.26 0.0
|
||||
1.86 3.19 0.0
|
||||
1.91 3.13 0.0
|
||||
1.96 3.06 0.0
|
||||
2.01 2.99 0.0
|
||||
2.05 2.92 0.0
|
||||
2.09 2.86 0.0
|
||||
2.13 2.79 0.0
|
||||
2.16 2.72 0.0
|
||||
2.19 2.65 0.0
|
||||
2.22 2.58 0.0
|
||||
2.24 2.52 0.0
|
||||
2.26 2.45 0.0
|
||||
2.28 2.38 0.0
|
||||
2.29 2.31 0.0
|
||||
2.31 2.24 0.0
|
||||
2.32 2.18 0.0
|
||||
2.32 2.11 0.0
|
||||
2.32 2.04 0.0
|
||||
2.32 1.97 0.0
|
||||
2.32 1.90 0.0
|
||||
2.31 1.83 0.0
|
||||
2.31 1.76 0.0
|
||||
2.29 1.70 0.0
|
||||
2.28 1.63 0.0
|
||||
2.26 1.56 0.0
|
||||
2.24 1.49 0.0
|
||||
2.21 1.42 0.0
|
||||
2.19 1.36 0.0
|
||||
2.16 1.29 0.0
|
||||
2.12 1.22 0.0
|
||||
2.09 1.15 0.0
|
||||
2.05 1.08 0.0
|
||||
2.00 1.02 0.0
|
||||
1.96 0.95 0.0
|
||||
1.91 0.88 0.0
|
||||
1.86 0.81 0.0
|
||||
1.80 0.74 0.0
|
||||
1.74 0.68 0.0
|
||||
1.68 0.61 0.0
|
||||
1.62 0.54 0.0
|
||||
1.55 0.47 0.0
|
||||
1.48 0.41 0.0
|
||||
1.41 0.34 0.0
|
||||
1.33 0.27 0.0
|
||||
1.25 0.20 0.0
|
||||
1.17 0.13 0.0
|
||||
1.08 0.07 0.0
|
||||
1.00 0.00 0.0
|
||||
1.00 4.00 0.0
|
||||
1.03 3.93 0.0
|
||||
1.07 3.86 0.0
|
||||
1.10 3.80 0.0
|
||||
1.13 3.73 0.0
|
||||
1.16 3.66 0.0
|
||||
1.19 3.59 0.0
|
||||
1.22 3.53 0.0
|
||||
1.24 3.46 0.0
|
||||
1.27 3.39 0.0
|
||||
1.29 3.32 0.0
|
||||
1.31 3.26 0.0
|
||||
1.34 3.19 0.0
|
||||
1.36 3.12 0.0
|
||||
1.37 3.05 0.0
|
||||
1.39 2.99 0.0
|
||||
1.41 2.92 0.0
|
||||
1.42 2.85 0.0
|
||||
1.44 2.78 0.0
|
||||
1.45 2.71 0.0
|
||||
1.46 2.65 0.0
|
||||
1.47 2.58 0.0
|
||||
1.48 2.51 0.0
|
||||
1.49 2.44 0.0
|
||||
1.50 2.37 0.0
|
||||
1.50 2.31 0.0
|
||||
1.51 2.24 0.0
|
||||
1.51 2.17 0.0
|
||||
1.51 2.10 0.0
|
||||
1.52 2.04 0.0
|
||||
1.52 1.97 0.0
|
||||
1.51 1.90 0.0
|
||||
1.51 1.83 0.0
|
||||
1.51 1.76 0.0
|
||||
1.50 1.70 0.0
|
||||
1.50 1.63 0.0
|
||||
1.49 1.56 0.0
|
||||
1.48 1.49 0.0
|
||||
1.47 1.42 0.0
|
||||
1.46 1.36 0.0
|
||||
1.45 1.29 0.0
|
||||
1.44 1.22 0.0
|
||||
1.42 1.15 0.0
|
||||
1.41 1.08 0.0
|
||||
1.39 1.02 0.0
|
||||
1.37 0.95 0.0
|
||||
1.35 0.88 0.0
|
||||
1.33 0.81 0.0
|
||||
1.31 0.75 0.0
|
||||
1.29 0.68 0.0
|
||||
1.27 0.61 0.0
|
||||
1.24 0.54 0.0
|
||||
1.21 0.47 0.0
|
||||
1.19 0.41 0.0
|
||||
1.16 0.34 0.0
|
||||
1.13 0.27 0.0
|
||||
1.10 0.20 0.0
|
||||
1.07 0.14 0.0
|
||||
1.03 0.07 0.0
|
||||
CELLS 299 598
|
||||
1 0
|
||||
1 1
|
||||
1 2
|
||||
1 3
|
||||
1 4
|
||||
1 5
|
||||
1 6
|
||||
1 7
|
||||
1 8
|
||||
1 9
|
||||
1 10
|
||||
1 11
|
||||
1 12
|
||||
1 13
|
||||
1 14
|
||||
1 15
|
||||
1 16
|
||||
1 17
|
||||
1 18
|
||||
1 19
|
||||
1 20
|
||||
1 21
|
||||
1 22
|
||||
1 23
|
||||
1 24
|
||||
1 25
|
||||
1 26
|
||||
1 27
|
||||
1 28
|
||||
1 29
|
||||
1 30
|
||||
1 31
|
||||
1 32
|
||||
1 33
|
||||
1 34
|
||||
1 35
|
||||
1 36
|
||||
1 37
|
||||
1 38
|
||||
1 39
|
||||
1 40
|
||||
1 41
|
||||
1 42
|
||||
1 43
|
||||
1 44
|
||||
1 45
|
||||
1 46
|
||||
1 47
|
||||
1 48
|
||||
1 49
|
||||
1 50
|
||||
1 51
|
||||
1 52
|
||||
1 53
|
||||
1 54
|
||||
1 55
|
||||
1 56
|
||||
1 57
|
||||
1 58
|
||||
1 59
|
||||
1 60
|
||||
1 61
|
||||
1 62
|
||||
1 63
|
||||
1 64
|
||||
1 65
|
||||
1 66
|
||||
1 67
|
||||
1 68
|
||||
1 69
|
||||
1 70
|
||||
1 71
|
||||
1 72
|
||||
1 73
|
||||
1 74
|
||||
1 75
|
||||
1 76
|
||||
1 77
|
||||
1 78
|
||||
1 79
|
||||
1 80
|
||||
1 81
|
||||
1 82
|
||||
1 83
|
||||
1 84
|
||||
1 85
|
||||
1 86
|
||||
1 87
|
||||
1 88
|
||||
1 89
|
||||
1 90
|
||||
1 91
|
||||
1 92
|
||||
1 93
|
||||
1 94
|
||||
1 95
|
||||
1 96
|
||||
1 97
|
||||
1 98
|
||||
1 99
|
||||
1 100
|
||||
1 101
|
||||
1 102
|
||||
1 103
|
||||
1 104
|
||||
1 105
|
||||
1 106
|
||||
1 107
|
||||
1 108
|
||||
1 109
|
||||
1 110
|
||||
1 111
|
||||
1 112
|
||||
1 113
|
||||
1 114
|
||||
1 115
|
||||
1 116
|
||||
1 117
|
||||
1 118
|
||||
1 119
|
||||
1 120
|
||||
1 121
|
||||
1 122
|
||||
1 123
|
||||
1 124
|
||||
1 125
|
||||
1 126
|
||||
1 127
|
||||
1 128
|
||||
1 129
|
||||
1 130
|
||||
1 131
|
||||
1 132
|
||||
1 133
|
||||
1 134
|
||||
1 135
|
||||
1 136
|
||||
1 137
|
||||
1 138
|
||||
1 139
|
||||
1 140
|
||||
1 141
|
||||
1 142
|
||||
1 143
|
||||
1 144
|
||||
1 145
|
||||
1 146
|
||||
1 147
|
||||
1 148
|
||||
1 149
|
||||
1 150
|
||||
1 151
|
||||
1 152
|
||||
1 153
|
||||
1 154
|
||||
1 155
|
||||
1 156
|
||||
1 157
|
||||
1 158
|
||||
1 159
|
||||
1 160
|
||||
1 161
|
||||
1 162
|
||||
1 163
|
||||
1 164
|
||||
1 165
|
||||
1 166
|
||||
1 167
|
||||
1 168
|
||||
1 169
|
||||
1 170
|
||||
1 171
|
||||
1 172
|
||||
1 173
|
||||
1 174
|
||||
1 175
|
||||
1 176
|
||||
1 177
|
||||
1 178
|
||||
1 179
|
||||
1 180
|
||||
1 181
|
||||
1 182
|
||||
1 183
|
||||
1 184
|
||||
1 185
|
||||
1 186
|
||||
1 187
|
||||
1 188
|
||||
1 189
|
||||
1 190
|
||||
1 191
|
||||
1 192
|
||||
1 193
|
||||
1 194
|
||||
1 195
|
||||
1 196
|
||||
1 197
|
||||
1 198
|
||||
1 199
|
||||
1 200
|
||||
1 201
|
||||
1 202
|
||||
1 203
|
||||
1 204
|
||||
1 205
|
||||
1 206
|
||||
1 207
|
||||
1 208
|
||||
1 209
|
||||
1 210
|
||||
1 211
|
||||
1 212
|
||||
1 213
|
||||
1 214
|
||||
1 215
|
||||
1 216
|
||||
1 217
|
||||
1 218
|
||||
1 219
|
||||
1 220
|
||||
1 221
|
||||
1 222
|
||||
1 223
|
||||
1 224
|
||||
1 225
|
||||
1 226
|
||||
1 227
|
||||
1 228
|
||||
1 229
|
||||
1 230
|
||||
1 231
|
||||
1 232
|
||||
1 233
|
||||
1 234
|
||||
1 235
|
||||
1 236
|
||||
1 237
|
||||
1 238
|
||||
1 239
|
||||
1 240
|
||||
1 241
|
||||
1 242
|
||||
1 243
|
||||
1 244
|
||||
1 245
|
||||
1 246
|
||||
1 247
|
||||
1 248
|
||||
1 249
|
||||
1 250
|
||||
1 251
|
||||
1 252
|
||||
1 253
|
||||
1 254
|
||||
1 255
|
||||
1 256
|
||||
1 257
|
||||
1 258
|
||||
1 259
|
||||
1 260
|
||||
1 261
|
||||
1 262
|
||||
1 263
|
||||
1 264
|
||||
1 265
|
||||
1 266
|
||||
1 267
|
||||
1 268
|
||||
1 269
|
||||
1 270
|
||||
1 271
|
||||
1 272
|
||||
1 273
|
||||
1 274
|
||||
1 275
|
||||
1 276
|
||||
1 277
|
||||
1 278
|
||||
1 279
|
||||
1 280
|
||||
1 281
|
||||
1 282
|
||||
1 283
|
||||
1 284
|
||||
1 285
|
||||
1 286
|
||||
1 287
|
||||
1 288
|
||||
1 289
|
||||
1 290
|
||||
1 291
|
||||
1 292
|
||||
1 293
|
||||
1 294
|
||||
1 295
|
||||
1 296
|
||||
1 297
|
||||
1 298
|
||||
CELL_TYPES 299
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
1089
BasicSolver/2D-seq/vtk_files/particles11.vtk
Normal file
1089
BasicSolver/2D-seq/vtk_files/particles11.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1089
BasicSolver/2D-seq/vtk_files/particles12.vtk
Normal file
1089
BasicSolver/2D-seq/vtk_files/particles12.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1269
BasicSolver/2D-seq/vtk_files/particles13.vtk
Normal file
1269
BasicSolver/2D-seq/vtk_files/particles13.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1269
BasicSolver/2D-seq/vtk_files/particles14.vtk
Normal file
1269
BasicSolver/2D-seq/vtk_files/particles14.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1449
BasicSolver/2D-seq/vtk_files/particles15.vtk
Normal file
1449
BasicSolver/2D-seq/vtk_files/particles15.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1449
BasicSolver/2D-seq/vtk_files/particles16.vtk
Normal file
1449
BasicSolver/2D-seq/vtk_files/particles16.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1629
BasicSolver/2D-seq/vtk_files/particles17.vtk
Normal file
1629
BasicSolver/2D-seq/vtk_files/particles17.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1629
BasicSolver/2D-seq/vtk_files/particles18.vtk
Normal file
1629
BasicSolver/2D-seq/vtk_files/particles18.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1809
BasicSolver/2D-seq/vtk_files/particles19.vtk
Normal file
1809
BasicSolver/2D-seq/vtk_files/particles19.vtk
Normal file
File diff suppressed because it is too large
Load Diff
189
BasicSolver/2D-seq/vtk_files/particles2.vtk
Normal file
189
BasicSolver/2D-seq/vtk_files/particles2.vtk
Normal file
@ -0,0 +1,189 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
2
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 59 float
|
||||
1.00 4.00 0.0
|
||||
1.03 3.93 0.0
|
||||
1.06 3.86 0.0
|
||||
1.09 3.80 0.0
|
||||
1.11 3.73 0.0
|
||||
1.14 3.66 0.0
|
||||
1.16 3.59 0.0
|
||||
1.18 3.53 0.0
|
||||
1.21 3.46 0.0
|
||||
1.23 3.39 0.0
|
||||
1.25 3.32 0.0
|
||||
1.27 3.26 0.0
|
||||
1.28 3.19 0.0
|
||||
1.30 3.12 0.0
|
||||
1.32 3.05 0.0
|
||||
1.33 2.99 0.0
|
||||
1.35 2.92 0.0
|
||||
1.36 2.85 0.0
|
||||
1.37 2.78 0.0
|
||||
1.38 2.71 0.0
|
||||
1.39 2.65 0.0
|
||||
1.40 2.58 0.0
|
||||
1.41 2.51 0.0
|
||||
1.42 2.44 0.0
|
||||
1.42 2.37 0.0
|
||||
1.43 2.31 0.0
|
||||
1.43 2.24 0.0
|
||||
1.43 2.17 0.0
|
||||
1.44 2.10 0.0
|
||||
1.44 2.04 0.0
|
||||
1.44 1.97 0.0
|
||||
1.44 1.90 0.0
|
||||
1.43 1.83 0.0
|
||||
1.43 1.76 0.0
|
||||
1.43 1.70 0.0
|
||||
1.42 1.63 0.0
|
||||
1.42 1.56 0.0
|
||||
1.41 1.49 0.0
|
||||
1.40 1.42 0.0
|
||||
1.39 1.36 0.0
|
||||
1.38 1.29 0.0
|
||||
1.37 1.22 0.0
|
||||
1.36 1.15 0.0
|
||||
1.35 1.08 0.0
|
||||
1.33 1.02 0.0
|
||||
1.32 0.95 0.0
|
||||
1.30 0.88 0.0
|
||||
1.28 0.81 0.0
|
||||
1.26 0.75 0.0
|
||||
1.25 0.68 0.0
|
||||
1.23 0.61 0.0
|
||||
1.20 0.54 0.0
|
||||
1.18 0.47 0.0
|
||||
1.16 0.41 0.0
|
||||
1.14 0.34 0.0
|
||||
1.11 0.27 0.0
|
||||
1.08 0.20 0.0
|
||||
1.06 0.14 0.0
|
||||
1.03 0.07 0.0
|
||||
CELLS 59 118
|
||||
1 0
|
||||
1 1
|
||||
1 2
|
||||
1 3
|
||||
1 4
|
||||
1 5
|
||||
1 6
|
||||
1 7
|
||||
1 8
|
||||
1 9
|
||||
1 10
|
||||
1 11
|
||||
1 12
|
||||
1 13
|
||||
1 14
|
||||
1 15
|
||||
1 16
|
||||
1 17
|
||||
1 18
|
||||
1 19
|
||||
1 20
|
||||
1 21
|
||||
1 22
|
||||
1 23
|
||||
1 24
|
||||
1 25
|
||||
1 26
|
||||
1 27
|
||||
1 28
|
||||
1 29
|
||||
1 30
|
||||
1 31
|
||||
1 32
|
||||
1 33
|
||||
1 34
|
||||
1 35
|
||||
1 36
|
||||
1 37
|
||||
1 38
|
||||
1 39
|
||||
1 40
|
||||
1 41
|
||||
1 42
|
||||
1 43
|
||||
1 44
|
||||
1 45
|
||||
1 46
|
||||
1 47
|
||||
1 48
|
||||
1 49
|
||||
1 50
|
||||
1 51
|
||||
1 52
|
||||
1 53
|
||||
1 54
|
||||
1 55
|
||||
1 56
|
||||
1 57
|
||||
1 58
|
||||
CELL_TYPES 59
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
1809
BasicSolver/2D-seq/vtk_files/particles20.vtk
Normal file
1809
BasicSolver/2D-seq/vtk_files/particles20.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1989
BasicSolver/2D-seq/vtk_files/particles21.vtk
Normal file
1989
BasicSolver/2D-seq/vtk_files/particles21.vtk
Normal file
File diff suppressed because it is too large
Load Diff
1989
BasicSolver/2D-seq/vtk_files/particles22.vtk
Normal file
1989
BasicSolver/2D-seq/vtk_files/particles22.vtk
Normal file
File diff suppressed because it is too large
Load Diff
2169
BasicSolver/2D-seq/vtk_files/particles23.vtk
Normal file
2169
BasicSolver/2D-seq/vtk_files/particles23.vtk
Normal file
File diff suppressed because it is too large
Load Diff
2169
BasicSolver/2D-seq/vtk_files/particles24.vtk
Normal file
2169
BasicSolver/2D-seq/vtk_files/particles24.vtk
Normal file
File diff suppressed because it is too large
Load Diff
2349
BasicSolver/2D-seq/vtk_files/particles25.vtk
Normal file
2349
BasicSolver/2D-seq/vtk_files/particles25.vtk
Normal file
File diff suppressed because it is too large
Load Diff
2349
BasicSolver/2D-seq/vtk_files/particles26.vtk
Normal file
2349
BasicSolver/2D-seq/vtk_files/particles26.vtk
Normal file
File diff suppressed because it is too large
Load Diff
2529
BasicSolver/2D-seq/vtk_files/particles27.vtk
Normal file
2529
BasicSolver/2D-seq/vtk_files/particles27.vtk
Normal file
File diff suppressed because it is too large
Load Diff
2529
BasicSolver/2D-seq/vtk_files/particles28.vtk
Normal file
2529
BasicSolver/2D-seq/vtk_files/particles28.vtk
Normal file
File diff suppressed because it is too large
Load Diff
2709
BasicSolver/2D-seq/vtk_files/particles29.vtk
Normal file
2709
BasicSolver/2D-seq/vtk_files/particles29.vtk
Normal file
File diff suppressed because it is too large
Load Diff
369
BasicSolver/2D-seq/vtk_files/particles3.vtk
Normal file
369
BasicSolver/2D-seq/vtk_files/particles3.vtk
Normal file
@ -0,0 +1,369 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
3
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 119 float
|
||||
1.00 4.00 0.0
|
||||
1.06 3.93 0.0
|
||||
1.11 3.86 0.0
|
||||
1.17 3.80 0.0
|
||||
1.22 3.73 0.0
|
||||
1.27 3.66 0.0
|
||||
1.32 3.59 0.0
|
||||
1.36 3.53 0.0
|
||||
1.40 3.46 0.0
|
||||
1.45 3.39 0.0
|
||||
1.48 3.33 0.0
|
||||
1.52 3.26 0.0
|
||||
1.56 3.19 0.0
|
||||
1.59 3.12 0.0
|
||||
1.62 3.05 0.0
|
||||
1.65 2.99 0.0
|
||||
1.68 2.92 0.0
|
||||
1.70 2.85 0.0
|
||||
1.73 2.78 0.0
|
||||
1.75 2.72 0.0
|
||||
1.77 2.65 0.0
|
||||
1.78 2.58 0.0
|
||||
1.80 2.51 0.0
|
||||
1.81 2.44 0.0
|
||||
1.82 2.38 0.0
|
||||
1.83 2.31 0.0
|
||||
1.84 2.24 0.0
|
||||
1.85 2.17 0.0
|
||||
1.85 2.10 0.0
|
||||
1.85 2.04 0.0
|
||||
1.85 1.97 0.0
|
||||
1.85 1.90 0.0
|
||||
1.85 1.83 0.0
|
||||
1.84 1.76 0.0
|
||||
1.83 1.70 0.0
|
||||
1.82 1.63 0.0
|
||||
1.81 1.56 0.0
|
||||
1.80 1.49 0.0
|
||||
1.78 1.42 0.0
|
||||
1.76 1.36 0.0
|
||||
1.74 1.29 0.0
|
||||
1.72 1.22 0.0
|
||||
1.70 1.15 0.0
|
||||
1.67 1.08 0.0
|
||||
1.65 1.02 0.0
|
||||
1.62 0.95 0.0
|
||||
1.59 0.88 0.0
|
||||
1.55 0.81 0.0
|
||||
1.52 0.74 0.0
|
||||
1.48 0.68 0.0
|
||||
1.44 0.61 0.0
|
||||
1.40 0.54 0.0
|
||||
1.36 0.47 0.0
|
||||
1.31 0.41 0.0
|
||||
1.26 0.34 0.0
|
||||
1.22 0.27 0.0
|
||||
1.16 0.20 0.0
|
||||
1.11 0.14 0.0
|
||||
1.05 0.07 0.0
|
||||
1.00 0.07 0.0
|
||||
1.00 4.00 0.0
|
||||
1.00 3.93 0.0
|
||||
1.01 3.86 0.0
|
||||
1.01 3.80 0.0
|
||||
1.01 3.73 0.0
|
||||
1.01 3.66 0.0
|
||||
1.01 3.59 0.0
|
||||
1.02 3.53 0.0
|
||||
1.02 3.46 0.0
|
||||
1.02 3.39 0.0
|
||||
1.02 3.32 0.0
|
||||
1.02 3.25 0.0
|
||||
1.03 3.19 0.0
|
||||
1.03 3.12 0.0
|
||||
1.03 3.05 0.0
|
||||
1.03 2.98 0.0
|
||||
1.03 2.92 0.0
|
||||
1.03 2.85 0.0
|
||||
1.03 2.78 0.0
|
||||
1.03 2.71 0.0
|
||||
1.04 2.64 0.0
|
||||
1.04 2.58 0.0
|
||||
1.04 2.51 0.0
|
||||
1.04 2.44 0.0
|
||||
1.04 2.37 0.0
|
||||
1.04 2.31 0.0
|
||||
1.04 2.24 0.0
|
||||
1.04 2.17 0.0
|
||||
1.04 2.10 0.0
|
||||
1.04 2.03 0.0
|
||||
1.04 1.97 0.0
|
||||
1.04 1.90 0.0
|
||||
1.04 1.83 0.0
|
||||
1.04 1.76 0.0
|
||||
1.04 1.69 0.0
|
||||
1.04 1.63 0.0
|
||||
1.04 1.56 0.0
|
||||
1.04 1.49 0.0
|
||||
1.04 1.42 0.0
|
||||
1.04 1.36 0.0
|
||||
1.03 1.29 0.0
|
||||
1.03 1.22 0.0
|
||||
1.03 1.15 0.0
|
||||
1.03 1.08 0.0
|
||||
1.03 1.02 0.0
|
||||
1.03 0.95 0.0
|
||||
1.03 0.88 0.0
|
||||
1.03 0.81 0.0
|
||||
1.02 0.75 0.0
|
||||
1.02 0.68 0.0
|
||||
1.02 0.61 0.0
|
||||
1.02 0.54 0.0
|
||||
1.02 0.47 0.0
|
||||
1.01 0.41 0.0
|
||||
1.01 0.34 0.0
|
||||
1.01 0.27 0.0
|
||||
1.01 0.20 0.0
|
||||
1.01 0.14 0.0
|
||||
1.00 0.07 0.0
|
||||
CELLS 119 238
|
||||
1 0
|
||||
1 1
|
||||
1 2
|
||||
1 3
|
||||
1 4
|
||||
1 5
|
||||
1 6
|
||||
1 7
|
||||
1 8
|
||||
1 9
|
||||
1 10
|
||||
1 11
|
||||
1 12
|
||||
1 13
|
||||
1 14
|
||||
1 15
|
||||
1 16
|
||||
1 17
|
||||
1 18
|
||||
1 19
|
||||
1 20
|
||||
1 21
|
||||
1 22
|
||||
1 23
|
||||
1 24
|
||||
1 25
|
||||
1 26
|
||||
1 27
|
||||
1 28
|
||||
1 29
|
||||
1 30
|
||||
1 31
|
||||
1 32
|
||||
1 33
|
||||
1 34
|
||||
1 35
|
||||
1 36
|
||||
1 37
|
||||
1 38
|
||||
1 39
|
||||
1 40
|
||||
1 41
|
||||
1 42
|
||||
1 43
|
||||
1 44
|
||||
1 45
|
||||
1 46
|
||||
1 47
|
||||
1 48
|
||||
1 49
|
||||
1 50
|
||||
1 51
|
||||
1 52
|
||||
1 53
|
||||
1 54
|
||||
1 55
|
||||
1 56
|
||||
1 57
|
||||
1 58
|
||||
1 59
|
||||
1 60
|
||||
1 61
|
||||
1 62
|
||||
1 63
|
||||
1 64
|
||||
1 65
|
||||
1 66
|
||||
1 67
|
||||
1 68
|
||||
1 69
|
||||
1 70
|
||||
1 71
|
||||
1 72
|
||||
1 73
|
||||
1 74
|
||||
1 75
|
||||
1 76
|
||||
1 77
|
||||
1 78
|
||||
1 79
|
||||
1 80
|
||||
1 81
|
||||
1 82
|
||||
1 83
|
||||
1 84
|
||||
1 85
|
||||
1 86
|
||||
1 87
|
||||
1 88
|
||||
1 89
|
||||
1 90
|
||||
1 91
|
||||
1 92
|
||||
1 93
|
||||
1 94
|
||||
1 95
|
||||
1 96
|
||||
1 97
|
||||
1 98
|
||||
1 99
|
||||
1 100
|
||||
1 101
|
||||
1 102
|
||||
1 103
|
||||
1 104
|
||||
1 105
|
||||
1 106
|
||||
1 107
|
||||
1 108
|
||||
1 109
|
||||
1 110
|
||||
1 111
|
||||
1 112
|
||||
1 113
|
||||
1 114
|
||||
1 115
|
||||
1 116
|
||||
1 117
|
||||
1 118
|
||||
CELL_TYPES 119
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
2709
BasicSolver/2D-seq/vtk_files/particles30.vtk
Normal file
2709
BasicSolver/2D-seq/vtk_files/particles30.vtk
Normal file
File diff suppressed because it is too large
Load Diff
2889
BasicSolver/2D-seq/vtk_files/particles31.vtk
Normal file
2889
BasicSolver/2D-seq/vtk_files/particles31.vtk
Normal file
File diff suppressed because it is too large
Load Diff
2889
BasicSolver/2D-seq/vtk_files/particles32.vtk
Normal file
2889
BasicSolver/2D-seq/vtk_files/particles32.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3069
BasicSolver/2D-seq/vtk_files/particles33.vtk
Normal file
3069
BasicSolver/2D-seq/vtk_files/particles33.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3069
BasicSolver/2D-seq/vtk_files/particles34.vtk
Normal file
3069
BasicSolver/2D-seq/vtk_files/particles34.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3249
BasicSolver/2D-seq/vtk_files/particles35.vtk
Normal file
3249
BasicSolver/2D-seq/vtk_files/particles35.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3249
BasicSolver/2D-seq/vtk_files/particles36.vtk
Normal file
3249
BasicSolver/2D-seq/vtk_files/particles36.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3429
BasicSolver/2D-seq/vtk_files/particles37.vtk
Normal file
3429
BasicSolver/2D-seq/vtk_files/particles37.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3429
BasicSolver/2D-seq/vtk_files/particles38.vtk
Normal file
3429
BasicSolver/2D-seq/vtk_files/particles38.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3609
BasicSolver/2D-seq/vtk_files/particles39.vtk
Normal file
3609
BasicSolver/2D-seq/vtk_files/particles39.vtk
Normal file
File diff suppressed because it is too large
Load Diff
369
BasicSolver/2D-seq/vtk_files/particles4.vtk
Normal file
369
BasicSolver/2D-seq/vtk_files/particles4.vtk
Normal file
@ -0,0 +1,369 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
4
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 119 float
|
||||
1.00 4.00 0.0
|
||||
1.08 3.93 0.0
|
||||
1.17 3.87 0.0
|
||||
1.25 3.80 0.0
|
||||
1.32 3.73 0.0
|
||||
1.40 3.66 0.0
|
||||
1.47 3.60 0.0
|
||||
1.54 3.53 0.0
|
||||
1.60 3.46 0.0
|
||||
1.66 3.39 0.0
|
||||
1.72 3.33 0.0
|
||||
1.77 3.26 0.0
|
||||
1.83 3.19 0.0
|
||||
1.88 3.13 0.0
|
||||
1.92 3.06 0.0
|
||||
1.97 2.99 0.0
|
||||
2.01 2.92 0.0
|
||||
2.04 2.86 0.0
|
||||
2.08 2.79 0.0
|
||||
2.11 2.72 0.0
|
||||
2.14 2.65 0.0
|
||||
2.16 2.58 0.0
|
||||
2.19 2.52 0.0
|
||||
2.21 2.45 0.0
|
||||
2.22 2.38 0.0
|
||||
2.24 2.31 0.0
|
||||
2.25 2.24 0.0
|
||||
2.26 2.17 0.0
|
||||
2.26 2.11 0.0
|
||||
2.27 2.04 0.0
|
||||
2.27 1.97 0.0
|
||||
2.26 1.90 0.0
|
||||
2.26 1.83 0.0
|
||||
2.25 1.76 0.0
|
||||
2.24 1.70 0.0
|
||||
2.22 1.63 0.0
|
||||
2.20 1.56 0.0
|
||||
2.18 1.49 0.0
|
||||
2.16 1.42 0.0
|
||||
2.13 1.35 0.0
|
||||
2.11 1.29 0.0
|
||||
2.07 1.22 0.0
|
||||
2.04 1.15 0.0
|
||||
2.00 1.08 0.0
|
||||
1.96 1.01 0.0
|
||||
1.92 0.95 0.0
|
||||
1.87 0.88 0.0
|
||||
1.82 0.81 0.0
|
||||
1.77 0.74 0.0
|
||||
1.71 0.68 0.0
|
||||
1.66 0.61 0.0
|
||||
1.59 0.54 0.0
|
||||
1.53 0.47 0.0
|
||||
1.46 0.41 0.0
|
||||
1.39 0.34 0.0
|
||||
1.32 0.27 0.0
|
||||
1.24 0.20 0.0
|
||||
1.16 0.13 0.0
|
||||
1.08 0.07 0.0
|
||||
1.03 0.07 0.0
|
||||
1.00 4.00 0.0
|
||||
1.03 3.93 0.0
|
||||
1.06 3.86 0.0
|
||||
1.09 3.80 0.0
|
||||
1.12 3.73 0.0
|
||||
1.14 3.66 0.0
|
||||
1.17 3.59 0.0
|
||||
1.19 3.53 0.0
|
||||
1.22 3.46 0.0
|
||||
1.24 3.39 0.0
|
||||
1.26 3.32 0.0
|
||||
1.28 3.26 0.0
|
||||
1.30 3.19 0.0
|
||||
1.31 3.12 0.0
|
||||
1.33 3.05 0.0
|
||||
1.35 2.99 0.0
|
||||
1.36 2.92 0.0
|
||||
1.38 2.85 0.0
|
||||
1.39 2.78 0.0
|
||||
1.40 2.71 0.0
|
||||
1.41 2.65 0.0
|
||||
1.42 2.58 0.0
|
||||
1.43 2.51 0.0
|
||||
1.43 2.44 0.0
|
||||
1.44 2.37 0.0
|
||||
1.45 2.31 0.0
|
||||
1.45 2.24 0.0
|
||||
1.45 2.17 0.0
|
||||
1.46 2.10 0.0
|
||||
1.46 2.04 0.0
|
||||
1.46 1.97 0.0
|
||||
1.46 1.90 0.0
|
||||
1.45 1.83 0.0
|
||||
1.45 1.76 0.0
|
||||
1.45 1.70 0.0
|
||||
1.44 1.63 0.0
|
||||
1.43 1.56 0.0
|
||||
1.43 1.49 0.0
|
||||
1.42 1.42 0.0
|
||||
1.41 1.36 0.0
|
||||
1.40 1.29 0.0
|
||||
1.39 1.22 0.0
|
||||
1.37 1.15 0.0
|
||||
1.36 1.08 0.0
|
||||
1.35 1.02 0.0
|
||||
1.33 0.95 0.0
|
||||
1.31 0.88 0.0
|
||||
1.30 0.81 0.0
|
||||
1.28 0.75 0.0
|
||||
1.26 0.68 0.0
|
||||
1.24 0.61 0.0
|
||||
1.21 0.54 0.0
|
||||
1.19 0.47 0.0
|
||||
1.17 0.41 0.0
|
||||
1.14 0.34 0.0
|
||||
1.11 0.27 0.0
|
||||
1.09 0.20 0.0
|
||||
1.06 0.14 0.0
|
||||
1.03 0.07 0.0
|
||||
CELLS 119 238
|
||||
1 0
|
||||
1 1
|
||||
1 2
|
||||
1 3
|
||||
1 4
|
||||
1 5
|
||||
1 6
|
||||
1 7
|
||||
1 8
|
||||
1 9
|
||||
1 10
|
||||
1 11
|
||||
1 12
|
||||
1 13
|
||||
1 14
|
||||
1 15
|
||||
1 16
|
||||
1 17
|
||||
1 18
|
||||
1 19
|
||||
1 20
|
||||
1 21
|
||||
1 22
|
||||
1 23
|
||||
1 24
|
||||
1 25
|
||||
1 26
|
||||
1 27
|
||||
1 28
|
||||
1 29
|
||||
1 30
|
||||
1 31
|
||||
1 32
|
||||
1 33
|
||||
1 34
|
||||
1 35
|
||||
1 36
|
||||
1 37
|
||||
1 38
|
||||
1 39
|
||||
1 40
|
||||
1 41
|
||||
1 42
|
||||
1 43
|
||||
1 44
|
||||
1 45
|
||||
1 46
|
||||
1 47
|
||||
1 48
|
||||
1 49
|
||||
1 50
|
||||
1 51
|
||||
1 52
|
||||
1 53
|
||||
1 54
|
||||
1 55
|
||||
1 56
|
||||
1 57
|
||||
1 58
|
||||
1 59
|
||||
1 60
|
||||
1 61
|
||||
1 62
|
||||
1 63
|
||||
1 64
|
||||
1 65
|
||||
1 66
|
||||
1 67
|
||||
1 68
|
||||
1 69
|
||||
1 70
|
||||
1 71
|
||||
1 72
|
||||
1 73
|
||||
1 74
|
||||
1 75
|
||||
1 76
|
||||
1 77
|
||||
1 78
|
||||
1 79
|
||||
1 80
|
||||
1 81
|
||||
1 82
|
||||
1 83
|
||||
1 84
|
||||
1 85
|
||||
1 86
|
||||
1 87
|
||||
1 88
|
||||
1 89
|
||||
1 90
|
||||
1 91
|
||||
1 92
|
||||
1 93
|
||||
1 94
|
||||
1 95
|
||||
1 96
|
||||
1 97
|
||||
1 98
|
||||
1 99
|
||||
1 100
|
||||
1 101
|
||||
1 102
|
||||
1 103
|
||||
1 104
|
||||
1 105
|
||||
1 106
|
||||
1 107
|
||||
1 108
|
||||
1 109
|
||||
1 110
|
||||
1 111
|
||||
1 112
|
||||
1 113
|
||||
1 114
|
||||
1 115
|
||||
1 116
|
||||
1 117
|
||||
1 118
|
||||
CELL_TYPES 119
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
3789
BasicSolver/2D-seq/vtk_files/particles40.vtk
Normal file
3789
BasicSolver/2D-seq/vtk_files/particles40.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3789
BasicSolver/2D-seq/vtk_files/particles41.vtk
Normal file
3789
BasicSolver/2D-seq/vtk_files/particles41.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3969
BasicSolver/2D-seq/vtk_files/particles42.vtk
Normal file
3969
BasicSolver/2D-seq/vtk_files/particles42.vtk
Normal file
File diff suppressed because it is too large
Load Diff
3969
BasicSolver/2D-seq/vtk_files/particles43.vtk
Normal file
3969
BasicSolver/2D-seq/vtk_files/particles43.vtk
Normal file
File diff suppressed because it is too large
Load Diff
4149
BasicSolver/2D-seq/vtk_files/particles44.vtk
Normal file
4149
BasicSolver/2D-seq/vtk_files/particles44.vtk
Normal file
File diff suppressed because it is too large
Load Diff
4149
BasicSolver/2D-seq/vtk_files/particles45.vtk
Normal file
4149
BasicSolver/2D-seq/vtk_files/particles45.vtk
Normal file
File diff suppressed because it is too large
Load Diff
4329
BasicSolver/2D-seq/vtk_files/particles46.vtk
Normal file
4329
BasicSolver/2D-seq/vtk_files/particles46.vtk
Normal file
File diff suppressed because it is too large
Load Diff
4329
BasicSolver/2D-seq/vtk_files/particles47.vtk
Normal file
4329
BasicSolver/2D-seq/vtk_files/particles47.vtk
Normal file
File diff suppressed because it is too large
Load Diff
4509
BasicSolver/2D-seq/vtk_files/particles48.vtk
Normal file
4509
BasicSolver/2D-seq/vtk_files/particles48.vtk
Normal file
File diff suppressed because it is too large
Load Diff
4509
BasicSolver/2D-seq/vtk_files/particles49.vtk
Normal file
4509
BasicSolver/2D-seq/vtk_files/particles49.vtk
Normal file
File diff suppressed because it is too large
Load Diff
549
BasicSolver/2D-seq/vtk_files/particles5.vtk
Normal file
549
BasicSolver/2D-seq/vtk_files/particles5.vtk
Normal file
@ -0,0 +1,549 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
5
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 179 float
|
||||
1.00 4.00 0.0
|
||||
1.11 3.93 0.0
|
||||
1.22 3.87 0.0
|
||||
1.33 3.80 0.0
|
||||
1.43 3.73 0.0
|
||||
1.53 3.66 0.0
|
||||
1.62 3.60 0.0
|
||||
1.71 3.53 0.0
|
||||
1.80 3.46 0.0
|
||||
1.88 3.40 0.0
|
||||
1.96 3.33 0.0
|
||||
2.03 3.26 0.0
|
||||
2.10 3.20 0.0
|
||||
2.16 3.13 0.0
|
||||
2.22 3.06 0.0
|
||||
2.28 2.99 0.0
|
||||
2.33 2.93 0.0
|
||||
2.38 2.86 0.0
|
||||
2.43 2.79 0.0
|
||||
2.47 2.72 0.0
|
||||
2.51 2.66 0.0
|
||||
2.54 2.59 0.0
|
||||
2.57 2.52 0.0
|
||||
2.60 2.45 0.0
|
||||
2.62 2.38 0.0
|
||||
2.64 2.32 0.0
|
||||
2.66 2.25 0.0
|
||||
2.67 2.18 0.0
|
||||
2.67 2.11 0.0
|
||||
2.68 2.04 0.0
|
||||
2.68 1.97 0.0
|
||||
2.67 1.90 0.0
|
||||
2.67 1.83 0.0
|
||||
2.65 1.76 0.0
|
||||
2.64 1.70 0.0
|
||||
2.62 1.63 0.0
|
||||
2.60 1.56 0.0
|
||||
2.57 1.49 0.0
|
||||
2.54 1.42 0.0
|
||||
2.50 1.35 0.0
|
||||
2.47 1.28 0.0
|
||||
2.42 1.22 0.0
|
||||
2.38 1.15 0.0
|
||||
2.33 1.08 0.0
|
||||
2.27 1.01 0.0
|
||||
2.22 0.95 0.0
|
||||
2.16 0.88 0.0
|
||||
2.09 0.81 0.0
|
||||
2.02 0.74 0.0
|
||||
1.95 0.67 0.0
|
||||
1.87 0.61 0.0
|
||||
1.79 0.54 0.0
|
||||
1.70 0.47 0.0
|
||||
1.61 0.41 0.0
|
||||
1.52 0.34 0.0
|
||||
1.42 0.27 0.0
|
||||
1.32 0.20 0.0
|
||||
1.22 0.13 0.0
|
||||
1.11 0.07 0.0
|
||||
1.06 0.07 0.0
|
||||
1.00 4.00 0.0
|
||||
1.06 3.93 0.0
|
||||
1.11 3.87 0.0
|
||||
1.17 3.80 0.0
|
||||
1.22 3.73 0.0
|
||||
1.27 3.66 0.0
|
||||
1.32 3.59 0.0
|
||||
1.37 3.53 0.0
|
||||
1.41 3.46 0.0
|
||||
1.45 3.39 0.0
|
||||
1.49 3.33 0.0
|
||||
1.53 3.26 0.0
|
||||
1.57 3.19 0.0
|
||||
1.60 3.12 0.0
|
||||
1.63 3.05 0.0
|
||||
1.66 2.99 0.0
|
||||
1.69 2.92 0.0
|
||||
1.72 2.85 0.0
|
||||
1.74 2.78 0.0
|
||||
1.76 2.72 0.0
|
||||
1.78 2.65 0.0
|
||||
1.80 2.58 0.0
|
||||
1.82 2.51 0.0
|
||||
1.83 2.44 0.0
|
||||
1.84 2.38 0.0
|
||||
1.85 2.31 0.0
|
||||
1.86 2.24 0.0
|
||||
1.87 2.17 0.0
|
||||
1.87 2.10 0.0
|
||||
1.87 2.04 0.0
|
||||
1.87 1.97 0.0
|
||||
1.87 1.90 0.0
|
||||
1.87 1.83 0.0
|
||||
1.86 1.76 0.0
|
||||
1.85 1.70 0.0
|
||||
1.84 1.63 0.0
|
||||
1.83 1.56 0.0
|
||||
1.82 1.49 0.0
|
||||
1.80 1.42 0.0
|
||||
1.78 1.36 0.0
|
||||
1.76 1.29 0.0
|
||||
1.74 1.22 0.0
|
||||
1.72 1.15 0.0
|
||||
1.69 1.08 0.0
|
||||
1.66 1.02 0.0
|
||||
1.63 0.95 0.0
|
||||
1.60 0.88 0.0
|
||||
1.56 0.81 0.0
|
||||
1.53 0.74 0.0
|
||||
1.49 0.68 0.0
|
||||
1.45 0.61 0.0
|
||||
1.41 0.54 0.0
|
||||
1.36 0.47 0.0
|
||||
1.32 0.41 0.0
|
||||
1.27 0.34 0.0
|
||||
1.22 0.27 0.0
|
||||
1.17 0.20 0.0
|
||||
1.11 0.13 0.0
|
||||
1.05 0.07 0.0
|
||||
1.00 0.00 0.0
|
||||
1.00 4.00 0.0
|
||||
1.00 3.93 0.0
|
||||
1.01 3.86 0.0
|
||||
1.01 3.80 0.0
|
||||
1.02 3.73 0.0
|
||||
1.02 3.66 0.0
|
||||
1.02 3.59 0.0
|
||||
1.03 3.53 0.0
|
||||
1.03 3.46 0.0
|
||||
1.03 3.39 0.0
|
||||
1.03 3.32 0.0
|
||||
1.04 3.25 0.0
|
||||
1.04 3.19 0.0
|
||||
1.04 3.12 0.0
|
||||
1.04 3.05 0.0
|
||||
1.05 2.98 0.0
|
||||
1.05 2.92 0.0
|
||||
1.05 2.85 0.0
|
||||
1.05 2.78 0.0
|
||||
1.05 2.71 0.0
|
||||
1.05 2.64 0.0
|
||||
1.06 2.58 0.0
|
||||
1.06 2.51 0.0
|
||||
1.06 2.44 0.0
|
||||
1.06 2.37 0.0
|
||||
1.06 2.31 0.0
|
||||
1.06 2.24 0.0
|
||||
1.06 2.17 0.0
|
||||
1.06 2.10 0.0
|
||||
1.06 2.03 0.0
|
||||
1.06 1.97 0.0
|
||||
1.06 1.90 0.0
|
||||
1.06 1.83 0.0
|
||||
1.06 1.76 0.0
|
||||
1.06 1.70 0.0
|
||||
1.06 1.63 0.0
|
||||
1.06 1.56 0.0
|
||||
1.06 1.49 0.0
|
||||
1.05 1.42 0.0
|
||||
1.05 1.36 0.0
|
||||
1.05 1.29 0.0
|
||||
1.05 1.22 0.0
|
||||
1.05 1.15 0.0
|
||||
1.05 1.08 0.0
|
||||
1.05 1.02 0.0
|
||||
1.04 0.95 0.0
|
||||
1.04 0.88 0.0
|
||||
1.04 0.81 0.0
|
||||
1.04 0.75 0.0
|
||||
1.03 0.68 0.0
|
||||
1.03 0.61 0.0
|
||||
1.03 0.54 0.0
|
||||
1.03 0.47 0.0
|
||||
1.02 0.41 0.0
|
||||
1.02 0.34 0.0
|
||||
1.02 0.27 0.0
|
||||
1.01 0.20 0.0
|
||||
1.01 0.14 0.0
|
||||
1.00 0.07 0.0
|
||||
CELLS 179 358
|
||||
1 0
|
||||
1 1
|
||||
1 2
|
||||
1 3
|
||||
1 4
|
||||
1 5
|
||||
1 6
|
||||
1 7
|
||||
1 8
|
||||
1 9
|
||||
1 10
|
||||
1 11
|
||||
1 12
|
||||
1 13
|
||||
1 14
|
||||
1 15
|
||||
1 16
|
||||
1 17
|
||||
1 18
|
||||
1 19
|
||||
1 20
|
||||
1 21
|
||||
1 22
|
||||
1 23
|
||||
1 24
|
||||
1 25
|
||||
1 26
|
||||
1 27
|
||||
1 28
|
||||
1 29
|
||||
1 30
|
||||
1 31
|
||||
1 32
|
||||
1 33
|
||||
1 34
|
||||
1 35
|
||||
1 36
|
||||
1 37
|
||||
1 38
|
||||
1 39
|
||||
1 40
|
||||
1 41
|
||||
1 42
|
||||
1 43
|
||||
1 44
|
||||
1 45
|
||||
1 46
|
||||
1 47
|
||||
1 48
|
||||
1 49
|
||||
1 50
|
||||
1 51
|
||||
1 52
|
||||
1 53
|
||||
1 54
|
||||
1 55
|
||||
1 56
|
||||
1 57
|
||||
1 58
|
||||
1 59
|
||||
1 60
|
||||
1 61
|
||||
1 62
|
||||
1 63
|
||||
1 64
|
||||
1 65
|
||||
1 66
|
||||
1 67
|
||||
1 68
|
||||
1 69
|
||||
1 70
|
||||
1 71
|
||||
1 72
|
||||
1 73
|
||||
1 74
|
||||
1 75
|
||||
1 76
|
||||
1 77
|
||||
1 78
|
||||
1 79
|
||||
1 80
|
||||
1 81
|
||||
1 82
|
||||
1 83
|
||||
1 84
|
||||
1 85
|
||||
1 86
|
||||
1 87
|
||||
1 88
|
||||
1 89
|
||||
1 90
|
||||
1 91
|
||||
1 92
|
||||
1 93
|
||||
1 94
|
||||
1 95
|
||||
1 96
|
||||
1 97
|
||||
1 98
|
||||
1 99
|
||||
1 100
|
||||
1 101
|
||||
1 102
|
||||
1 103
|
||||
1 104
|
||||
1 105
|
||||
1 106
|
||||
1 107
|
||||
1 108
|
||||
1 109
|
||||
1 110
|
||||
1 111
|
||||
1 112
|
||||
1 113
|
||||
1 114
|
||||
1 115
|
||||
1 116
|
||||
1 117
|
||||
1 118
|
||||
1 119
|
||||
1 120
|
||||
1 121
|
||||
1 122
|
||||
1 123
|
||||
1 124
|
||||
1 125
|
||||
1 126
|
||||
1 127
|
||||
1 128
|
||||
1 129
|
||||
1 130
|
||||
1 131
|
||||
1 132
|
||||
1 133
|
||||
1 134
|
||||
1 135
|
||||
1 136
|
||||
1 137
|
||||
1 138
|
||||
1 139
|
||||
1 140
|
||||
1 141
|
||||
1 142
|
||||
1 143
|
||||
1 144
|
||||
1 145
|
||||
1 146
|
||||
1 147
|
||||
1 148
|
||||
1 149
|
||||
1 150
|
||||
1 151
|
||||
1 152
|
||||
1 153
|
||||
1 154
|
||||
1 155
|
||||
1 156
|
||||
1 157
|
||||
1 158
|
||||
1 159
|
||||
1 160
|
||||
1 161
|
||||
1 162
|
||||
1 163
|
||||
1 164
|
||||
1 165
|
||||
1 166
|
||||
1 167
|
||||
1 168
|
||||
1 169
|
||||
1 170
|
||||
1 171
|
||||
1 172
|
||||
1 173
|
||||
1 174
|
||||
1 175
|
||||
1 176
|
||||
1 177
|
||||
1 178
|
||||
CELL_TYPES 179
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
4689
BasicSolver/2D-seq/vtk_files/particles50.vtk
Normal file
4689
BasicSolver/2D-seq/vtk_files/particles50.vtk
Normal file
File diff suppressed because it is too large
Load Diff
4689
BasicSolver/2D-seq/vtk_files/particles51.vtk
Normal file
4689
BasicSolver/2D-seq/vtk_files/particles51.vtk
Normal file
File diff suppressed because it is too large
Load Diff
4869
BasicSolver/2D-seq/vtk_files/particles52.vtk
Normal file
4869
BasicSolver/2D-seq/vtk_files/particles52.vtk
Normal file
File diff suppressed because it is too large
Load Diff
4869
BasicSolver/2D-seq/vtk_files/particles53.vtk
Normal file
4869
BasicSolver/2D-seq/vtk_files/particles53.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5049
BasicSolver/2D-seq/vtk_files/particles54.vtk
Normal file
5049
BasicSolver/2D-seq/vtk_files/particles54.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5049
BasicSolver/2D-seq/vtk_files/particles55.vtk
Normal file
5049
BasicSolver/2D-seq/vtk_files/particles55.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5229
BasicSolver/2D-seq/vtk_files/particles56.vtk
Normal file
5229
BasicSolver/2D-seq/vtk_files/particles56.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5229
BasicSolver/2D-seq/vtk_files/particles57.vtk
Normal file
5229
BasicSolver/2D-seq/vtk_files/particles57.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5409
BasicSolver/2D-seq/vtk_files/particles58.vtk
Normal file
5409
BasicSolver/2D-seq/vtk_files/particles58.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5409
BasicSolver/2D-seq/vtk_files/particles59.vtk
Normal file
5409
BasicSolver/2D-seq/vtk_files/particles59.vtk
Normal file
File diff suppressed because it is too large
Load Diff
549
BasicSolver/2D-seq/vtk_files/particles6.vtk
Normal file
549
BasicSolver/2D-seq/vtk_files/particles6.vtk
Normal file
@ -0,0 +1,549 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
6
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 179 float
|
||||
1.00 4.00 0.0
|
||||
1.14 3.93 0.0
|
||||
1.27 3.87 0.0
|
||||
1.41 3.80 0.0
|
||||
1.54 3.73 0.0
|
||||
1.66 3.66 0.0
|
||||
1.77 3.60 0.0
|
||||
1.89 3.53 0.0
|
||||
1.99 3.47 0.0
|
||||
2.09 3.40 0.0
|
||||
2.19 3.33 0.0
|
||||
2.28 3.27 0.0
|
||||
2.37 3.20 0.0
|
||||
2.45 3.13 0.0
|
||||
2.52 3.07 0.0
|
||||
2.60 3.00 0.0
|
||||
2.66 2.93 0.0
|
||||
2.72 2.87 0.0
|
||||
2.78 2.80 0.0
|
||||
2.83 2.73 0.0
|
||||
2.88 2.66 0.0
|
||||
2.92 2.60 0.0
|
||||
2.96 2.53 0.0
|
||||
2.99 2.46 0.0
|
||||
3.02 2.39 0.0
|
||||
3.04 2.32 0.0
|
||||
3.06 2.25 0.0
|
||||
3.07 2.18 0.0
|
||||
3.08 2.11 0.0
|
||||
3.08 2.04 0.0
|
||||
3.08 1.97 0.0
|
||||
3.08 1.90 0.0
|
||||
3.07 1.83 0.0
|
||||
3.05 1.76 0.0
|
||||
3.04 1.69 0.0
|
||||
3.01 1.62 0.0
|
||||
2.98 1.55 0.0
|
||||
2.95 1.49 0.0
|
||||
2.91 1.42 0.0
|
||||
2.87 1.35 0.0
|
||||
2.82 1.28 0.0
|
||||
2.77 1.21 0.0
|
||||
2.72 1.14 0.0
|
||||
2.65 1.08 0.0
|
||||
2.59 1.01 0.0
|
||||
2.51 0.94 0.0
|
||||
2.44 0.87 0.0
|
||||
2.36 0.81 0.0
|
||||
2.27 0.74 0.0
|
||||
2.18 0.67 0.0
|
||||
2.08 0.61 0.0
|
||||
1.98 0.54 0.0
|
||||
1.88 0.47 0.0
|
||||
1.76 0.40 0.0
|
||||
1.65 0.34 0.0
|
||||
1.53 0.27 0.0
|
||||
1.40 0.20 0.0
|
||||
1.27 0.13 0.0
|
||||
1.13 0.07 0.0
|
||||
1.08 0.07 0.0
|
||||
1.00 4.00 0.0
|
||||
1.08 3.93 0.0
|
||||
1.17 3.87 0.0
|
||||
1.25 3.80 0.0
|
||||
1.33 3.73 0.0
|
||||
1.40 3.66 0.0
|
||||
1.47 3.60 0.0
|
||||
1.54 3.53 0.0
|
||||
1.61 3.46 0.0
|
||||
1.67 3.39 0.0
|
||||
1.73 3.33 0.0
|
||||
1.79 3.26 0.0
|
||||
1.84 3.19 0.0
|
||||
1.89 3.13 0.0
|
||||
1.94 3.06 0.0
|
||||
1.98 2.99 0.0
|
||||
2.02 2.92 0.0
|
||||
2.06 2.86 0.0
|
||||
2.09 2.79 0.0
|
||||
2.13 2.72 0.0
|
||||
2.15 2.65 0.0
|
||||
2.18 2.58 0.0
|
||||
2.20 2.52 0.0
|
||||
2.22 2.45 0.0
|
||||
2.24 2.38 0.0
|
||||
2.26 2.31 0.0
|
||||
2.27 2.24 0.0
|
||||
2.28 2.17 0.0
|
||||
2.28 2.11 0.0
|
||||
2.29 2.04 0.0
|
||||
2.28 1.97 0.0
|
||||
2.28 1.90 0.0
|
||||
2.28 1.83 0.0
|
||||
2.27 1.76 0.0
|
||||
2.25 1.70 0.0
|
||||
2.24 1.63 0.0
|
||||
2.22 1.56 0.0
|
||||
2.20 1.49 0.0
|
||||
2.18 1.42 0.0
|
||||
2.15 1.35 0.0
|
||||
2.12 1.29 0.0
|
||||
2.09 1.22 0.0
|
||||
2.05 1.15 0.0
|
||||
2.02 1.08 0.0
|
||||
1.97 1.01 0.0
|
||||
1.93 0.95 0.0
|
||||
1.88 0.88 0.0
|
||||
1.83 0.81 0.0
|
||||
1.78 0.74 0.0
|
||||
1.72 0.68 0.0
|
||||
1.66 0.61 0.0
|
||||
1.60 0.54 0.0
|
||||
1.54 0.47 0.0
|
||||
1.47 0.41 0.0
|
||||
1.40 0.34 0.0
|
||||
1.32 0.27 0.0
|
||||
1.25 0.20 0.0
|
||||
1.16 0.13 0.0
|
||||
1.08 0.07 0.0
|
||||
1.00 0.00 0.0
|
||||
1.00 4.00 0.0
|
||||
1.03 3.93 0.0
|
||||
1.06 3.86 0.0
|
||||
1.09 3.80 0.0
|
||||
1.12 3.73 0.0
|
||||
1.15 3.66 0.0
|
||||
1.18 3.59 0.0
|
||||
1.20 3.53 0.0
|
||||
1.22 3.46 0.0
|
||||
1.25 3.39 0.0
|
||||
1.27 3.32 0.0
|
||||
1.29 3.26 0.0
|
||||
1.31 3.19 0.0
|
||||
1.33 3.12 0.0
|
||||
1.35 3.05 0.0
|
||||
1.36 2.99 0.0
|
||||
1.38 2.92 0.0
|
||||
1.39 2.85 0.0
|
||||
1.40 2.78 0.0
|
||||
1.42 2.71 0.0
|
||||
1.43 2.65 0.0
|
||||
1.44 2.58 0.0
|
||||
1.45 2.51 0.0
|
||||
1.45 2.44 0.0
|
||||
1.46 2.37 0.0
|
||||
1.47 2.31 0.0
|
||||
1.47 2.24 0.0
|
||||
1.47 2.17 0.0
|
||||
1.48 2.10 0.0
|
||||
1.48 2.04 0.0
|
||||
1.48 1.97 0.0
|
||||
1.48 1.90 0.0
|
||||
1.47 1.83 0.0
|
||||
1.47 1.76 0.0
|
||||
1.47 1.70 0.0
|
||||
1.46 1.63 0.0
|
||||
1.45 1.56 0.0
|
||||
1.45 1.49 0.0
|
||||
1.44 1.42 0.0
|
||||
1.43 1.36 0.0
|
||||
1.42 1.29 0.0
|
||||
1.40 1.22 0.0
|
||||
1.39 1.15 0.0
|
||||
1.38 1.08 0.0
|
||||
1.36 1.02 0.0
|
||||
1.34 0.95 0.0
|
||||
1.33 0.88 0.0
|
||||
1.31 0.81 0.0
|
||||
1.29 0.75 0.0
|
||||
1.27 0.68 0.0
|
||||
1.25 0.61 0.0
|
||||
1.22 0.54 0.0
|
||||
1.20 0.47 0.0
|
||||
1.17 0.41 0.0
|
||||
1.15 0.34 0.0
|
||||
1.12 0.27 0.0
|
||||
1.09 0.20 0.0
|
||||
1.06 0.14 0.0
|
||||
1.03 0.07 0.0
|
||||
CELLS 179 358
|
||||
1 0
|
||||
1 1
|
||||
1 2
|
||||
1 3
|
||||
1 4
|
||||
1 5
|
||||
1 6
|
||||
1 7
|
||||
1 8
|
||||
1 9
|
||||
1 10
|
||||
1 11
|
||||
1 12
|
||||
1 13
|
||||
1 14
|
||||
1 15
|
||||
1 16
|
||||
1 17
|
||||
1 18
|
||||
1 19
|
||||
1 20
|
||||
1 21
|
||||
1 22
|
||||
1 23
|
||||
1 24
|
||||
1 25
|
||||
1 26
|
||||
1 27
|
||||
1 28
|
||||
1 29
|
||||
1 30
|
||||
1 31
|
||||
1 32
|
||||
1 33
|
||||
1 34
|
||||
1 35
|
||||
1 36
|
||||
1 37
|
||||
1 38
|
||||
1 39
|
||||
1 40
|
||||
1 41
|
||||
1 42
|
||||
1 43
|
||||
1 44
|
||||
1 45
|
||||
1 46
|
||||
1 47
|
||||
1 48
|
||||
1 49
|
||||
1 50
|
||||
1 51
|
||||
1 52
|
||||
1 53
|
||||
1 54
|
||||
1 55
|
||||
1 56
|
||||
1 57
|
||||
1 58
|
||||
1 59
|
||||
1 60
|
||||
1 61
|
||||
1 62
|
||||
1 63
|
||||
1 64
|
||||
1 65
|
||||
1 66
|
||||
1 67
|
||||
1 68
|
||||
1 69
|
||||
1 70
|
||||
1 71
|
||||
1 72
|
||||
1 73
|
||||
1 74
|
||||
1 75
|
||||
1 76
|
||||
1 77
|
||||
1 78
|
||||
1 79
|
||||
1 80
|
||||
1 81
|
||||
1 82
|
||||
1 83
|
||||
1 84
|
||||
1 85
|
||||
1 86
|
||||
1 87
|
||||
1 88
|
||||
1 89
|
||||
1 90
|
||||
1 91
|
||||
1 92
|
||||
1 93
|
||||
1 94
|
||||
1 95
|
||||
1 96
|
||||
1 97
|
||||
1 98
|
||||
1 99
|
||||
1 100
|
||||
1 101
|
||||
1 102
|
||||
1 103
|
||||
1 104
|
||||
1 105
|
||||
1 106
|
||||
1 107
|
||||
1 108
|
||||
1 109
|
||||
1 110
|
||||
1 111
|
||||
1 112
|
||||
1 113
|
||||
1 114
|
||||
1 115
|
||||
1 116
|
||||
1 117
|
||||
1 118
|
||||
1 119
|
||||
1 120
|
||||
1 121
|
||||
1 122
|
||||
1 123
|
||||
1 124
|
||||
1 125
|
||||
1 126
|
||||
1 127
|
||||
1 128
|
||||
1 129
|
||||
1 130
|
||||
1 131
|
||||
1 132
|
||||
1 133
|
||||
1 134
|
||||
1 135
|
||||
1 136
|
||||
1 137
|
||||
1 138
|
||||
1 139
|
||||
1 140
|
||||
1 141
|
||||
1 142
|
||||
1 143
|
||||
1 144
|
||||
1 145
|
||||
1 146
|
||||
1 147
|
||||
1 148
|
||||
1 149
|
||||
1 150
|
||||
1 151
|
||||
1 152
|
||||
1 153
|
||||
1 154
|
||||
1 155
|
||||
1 156
|
||||
1 157
|
||||
1 158
|
||||
1 159
|
||||
1 160
|
||||
1 161
|
||||
1 162
|
||||
1 163
|
||||
1 164
|
||||
1 165
|
||||
1 166
|
||||
1 167
|
||||
1 168
|
||||
1 169
|
||||
1 170
|
||||
1 171
|
||||
1 172
|
||||
1 173
|
||||
1 174
|
||||
1 175
|
||||
1 176
|
||||
1 177
|
||||
1 178
|
||||
CELL_TYPES 179
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
5589
BasicSolver/2D-seq/vtk_files/particles60.vtk
Normal file
5589
BasicSolver/2D-seq/vtk_files/particles60.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5589
BasicSolver/2D-seq/vtk_files/particles61.vtk
Normal file
5589
BasicSolver/2D-seq/vtk_files/particles61.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5769
BasicSolver/2D-seq/vtk_files/particles62.vtk
Normal file
5769
BasicSolver/2D-seq/vtk_files/particles62.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5769
BasicSolver/2D-seq/vtk_files/particles63.vtk
Normal file
5769
BasicSolver/2D-seq/vtk_files/particles63.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5949
BasicSolver/2D-seq/vtk_files/particles64.vtk
Normal file
5949
BasicSolver/2D-seq/vtk_files/particles64.vtk
Normal file
File diff suppressed because it is too large
Load Diff
5949
BasicSolver/2D-seq/vtk_files/particles65.vtk
Normal file
5949
BasicSolver/2D-seq/vtk_files/particles65.vtk
Normal file
File diff suppressed because it is too large
Load Diff
6129
BasicSolver/2D-seq/vtk_files/particles66.vtk
Normal file
6129
BasicSolver/2D-seq/vtk_files/particles66.vtk
Normal file
File diff suppressed because it is too large
Load Diff
6129
BasicSolver/2D-seq/vtk_files/particles67.vtk
Normal file
6129
BasicSolver/2D-seq/vtk_files/particles67.vtk
Normal file
File diff suppressed because it is too large
Load Diff
6309
BasicSolver/2D-seq/vtk_files/particles68.vtk
Normal file
6309
BasicSolver/2D-seq/vtk_files/particles68.vtk
Normal file
File diff suppressed because it is too large
Load Diff
6489
BasicSolver/2D-seq/vtk_files/particles69.vtk
Normal file
6489
BasicSolver/2D-seq/vtk_files/particles69.vtk
Normal file
File diff suppressed because it is too large
Load Diff
729
BasicSolver/2D-seq/vtk_files/particles7.vtk
Normal file
729
BasicSolver/2D-seq/vtk_files/particles7.vtk
Normal file
@ -0,0 +1,729 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
7
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 239 float
|
||||
1.00 4.00 0.0
|
||||
1.16 3.93 0.0
|
||||
1.33 3.87 0.0
|
||||
1.49 3.80 0.0
|
||||
1.64 3.73 0.0
|
||||
1.79 3.67 0.0
|
||||
1.93 3.60 0.0
|
||||
2.06 3.53 0.0
|
||||
2.19 3.47 0.0
|
||||
2.31 3.40 0.0
|
||||
2.43 3.34 0.0
|
||||
2.53 3.27 0.0
|
||||
2.64 3.20 0.0
|
||||
2.73 3.14 0.0
|
||||
2.82 3.07 0.0
|
||||
2.91 3.01 0.0
|
||||
2.99 2.94 0.0
|
||||
3.06 2.88 0.0
|
||||
3.13 2.81 0.0
|
||||
3.19 2.74 0.0
|
||||
3.24 2.67 0.0
|
||||
3.29 2.61 0.0
|
||||
3.34 2.54 0.0
|
||||
3.37 2.47 0.0
|
||||
3.40 2.40 0.0
|
||||
3.43 2.33 0.0
|
||||
3.45 2.26 0.0
|
||||
3.47 2.19 0.0
|
||||
3.48 2.12 0.0
|
||||
3.48 2.05 0.0
|
||||
3.48 1.97 0.0
|
||||
3.48 1.90 0.0
|
||||
3.46 1.83 0.0
|
||||
3.45 1.76 0.0
|
||||
3.43 1.69 0.0
|
||||
3.40 1.62 0.0
|
||||
3.37 1.55 0.0
|
||||
3.33 1.48 0.0
|
||||
3.28 1.41 0.0
|
||||
3.23 1.34 0.0
|
||||
3.18 1.27 0.0
|
||||
3.12 1.21 0.0
|
||||
3.05 1.14 0.0
|
||||
2.98 1.07 0.0
|
||||
2.90 1.00 0.0
|
||||
2.81 0.94 0.0
|
||||
2.72 0.87 0.0
|
||||
2.62 0.80 0.0
|
||||
2.52 0.74 0.0
|
||||
2.41 0.67 0.0
|
||||
2.30 0.60 0.0
|
||||
2.18 0.54 0.0
|
||||
2.05 0.47 0.0
|
||||
1.91 0.40 0.0
|
||||
1.78 0.34 0.0
|
||||
1.63 0.27 0.0
|
||||
1.48 0.20 0.0
|
||||
1.32 0.13 0.0
|
||||
1.16 0.07 0.0
|
||||
1.11 0.07 0.0
|
||||
1.00 4.00 0.0
|
||||
1.11 3.93 0.0
|
||||
1.22 3.87 0.0
|
||||
1.33 3.80 0.0
|
||||
1.43 3.73 0.0
|
||||
1.53 3.66 0.0
|
||||
1.63 3.60 0.0
|
||||
1.72 3.53 0.0
|
||||
1.80 3.46 0.0
|
||||
1.89 3.40 0.0
|
||||
1.97 3.33 0.0
|
||||
2.04 3.26 0.0
|
||||
2.11 3.20 0.0
|
||||
2.18 3.13 0.0
|
||||
2.24 3.06 0.0
|
||||
2.30 2.99 0.0
|
||||
2.35 2.93 0.0
|
||||
2.40 2.86 0.0
|
||||
2.45 2.79 0.0
|
||||
2.49 2.72 0.0
|
||||
2.53 2.66 0.0
|
||||
2.56 2.59 0.0
|
||||
2.59 2.52 0.0
|
||||
2.62 2.45 0.0
|
||||
2.64 2.38 0.0
|
||||
2.66 2.32 0.0
|
||||
2.67 2.25 0.0
|
||||
2.69 2.18 0.0
|
||||
2.69 2.11 0.0
|
||||
2.70 2.04 0.0
|
||||
2.70 1.97 0.0
|
||||
2.69 1.90 0.0
|
||||
2.68 1.83 0.0
|
||||
2.67 1.76 0.0
|
||||
2.66 1.70 0.0
|
||||
2.64 1.63 0.0
|
||||
2.62 1.56 0.0
|
||||
2.59 1.49 0.0
|
||||
2.56 1.42 0.0
|
||||
2.52 1.35 0.0
|
||||
2.48 1.28 0.0
|
||||
2.44 1.22 0.0
|
||||
2.39 1.15 0.0
|
||||
2.34 1.08 0.0
|
||||
2.29 1.01 0.0
|
||||
2.23 0.95 0.0
|
||||
2.17 0.88 0.0
|
||||
2.10 0.81 0.0
|
||||
2.03 0.74 0.0
|
||||
1.96 0.68 0.0
|
||||
1.88 0.61 0.0
|
||||
1.80 0.54 0.0
|
||||
1.71 0.47 0.0
|
||||
1.62 0.40 0.0
|
||||
1.52 0.34 0.0
|
||||
1.43 0.27 0.0
|
||||
1.32 0.20 0.0
|
||||
1.22 0.13 0.0
|
||||
1.11 0.07 0.0
|
||||
1.00 0.00 0.0
|
||||
1.00 4.00 0.0
|
||||
1.06 3.93 0.0
|
||||
1.12 3.87 0.0
|
||||
1.17 3.80 0.0
|
||||
1.23 3.73 0.0
|
||||
1.28 3.66 0.0
|
||||
1.33 3.59 0.0
|
||||
1.38 3.53 0.0
|
||||
1.42 3.46 0.0
|
||||
1.46 3.39 0.0
|
||||
1.51 3.33 0.0
|
||||
1.54 3.26 0.0
|
||||
1.58 3.19 0.0
|
||||
1.62 3.12 0.0
|
||||
1.65 3.05 0.0
|
||||
1.68 2.99 0.0
|
||||
1.71 2.92 0.0
|
||||
1.73 2.85 0.0
|
||||
1.76 2.78 0.0
|
||||
1.78 2.72 0.0
|
||||
1.80 2.65 0.0
|
||||
1.82 2.58 0.0
|
||||
1.84 2.51 0.0
|
||||
1.85 2.44 0.0
|
||||
1.86 2.38 0.0
|
||||
1.87 2.31 0.0
|
||||
1.88 2.24 0.0
|
||||
1.89 2.17 0.0
|
||||
1.89 2.10 0.0
|
||||
1.89 2.04 0.0
|
||||
1.89 1.97 0.0
|
||||
1.89 1.90 0.0
|
||||
1.89 1.83 0.0
|
||||
1.88 1.76 0.0
|
||||
1.87 1.70 0.0
|
||||
1.86 1.63 0.0
|
||||
1.85 1.56 0.0
|
||||
1.83 1.49 0.0
|
||||
1.82 1.42 0.0
|
||||
1.80 1.36 0.0
|
||||
1.78 1.29 0.0
|
||||
1.76 1.22 0.0
|
||||
1.73 1.15 0.0
|
||||
1.71 1.08 0.0
|
||||
1.68 1.02 0.0
|
||||
1.65 0.95 0.0
|
||||
1.61 0.88 0.0
|
||||
1.58 0.81 0.0
|
||||
1.54 0.74 0.0
|
||||
1.50 0.68 0.0
|
||||
1.46 0.61 0.0
|
||||
1.42 0.54 0.0
|
||||
1.37 0.47 0.0
|
||||
1.32 0.41 0.0
|
||||
1.28 0.34 0.0
|
||||
1.22 0.27 0.0
|
||||
1.17 0.20 0.0
|
||||
1.11 0.13 0.0
|
||||
1.06 0.07 0.0
|
||||
1.00 0.00 0.0
|
||||
1.00 4.00 0.0
|
||||
1.01 3.93 0.0
|
||||
1.01 3.86 0.0
|
||||
1.02 3.80 0.0
|
||||
1.02 3.73 0.0
|
||||
1.02 3.66 0.0
|
||||
1.03 3.59 0.0
|
||||
1.03 3.53 0.0
|
||||
1.04 3.46 0.0
|
||||
1.04 3.39 0.0
|
||||
1.04 3.32 0.0
|
||||
1.05 3.25 0.0
|
||||
1.05 3.19 0.0
|
||||
1.05 3.12 0.0
|
||||
1.06 3.05 0.0
|
||||
1.06 2.98 0.0
|
||||
1.06 2.92 0.0
|
||||
1.07 2.85 0.0
|
||||
1.07 2.78 0.0
|
||||
1.07 2.71 0.0
|
||||
1.07 2.64 0.0
|
||||
1.07 2.58 0.0
|
||||
1.07 2.51 0.0
|
||||
1.08 2.44 0.0
|
||||
1.08 2.37 0.0
|
||||
1.08 2.31 0.0
|
||||
1.08 2.24 0.0
|
||||
1.08 2.17 0.0
|
||||
1.08 2.10 0.0
|
||||
1.08 2.03 0.0
|
||||
1.08 1.97 0.0
|
||||
1.08 1.90 0.0
|
||||
1.08 1.83 0.0
|
||||
1.08 1.76 0.0
|
||||
1.08 1.70 0.0
|
||||
1.08 1.63 0.0
|
||||
1.08 1.56 0.0
|
||||
1.07 1.49 0.0
|
||||
1.07 1.42 0.0
|
||||
1.07 1.36 0.0
|
||||
1.07 1.29 0.0
|
||||
1.07 1.22 0.0
|
||||
1.07 1.15 0.0
|
||||
1.06 1.08 0.0
|
||||
1.06 1.02 0.0
|
||||
1.06 0.95 0.0
|
||||
1.05 0.88 0.0
|
||||
1.05 0.81 0.0
|
||||
1.05 0.75 0.0
|
||||
1.04 0.68 0.0
|
||||
1.04 0.61 0.0
|
||||
1.04 0.54 0.0
|
||||
1.03 0.47 0.0
|
||||
1.03 0.41 0.0
|
||||
1.02 0.34 0.0
|
||||
1.02 0.27 0.0
|
||||
1.02 0.20 0.0
|
||||
1.01 0.14 0.0
|
||||
1.00 0.07 0.0
|
||||
CELLS 239 478
|
||||
1 0
|
||||
1 1
|
||||
1 2
|
||||
1 3
|
||||
1 4
|
||||
1 5
|
||||
1 6
|
||||
1 7
|
||||
1 8
|
||||
1 9
|
||||
1 10
|
||||
1 11
|
||||
1 12
|
||||
1 13
|
||||
1 14
|
||||
1 15
|
||||
1 16
|
||||
1 17
|
||||
1 18
|
||||
1 19
|
||||
1 20
|
||||
1 21
|
||||
1 22
|
||||
1 23
|
||||
1 24
|
||||
1 25
|
||||
1 26
|
||||
1 27
|
||||
1 28
|
||||
1 29
|
||||
1 30
|
||||
1 31
|
||||
1 32
|
||||
1 33
|
||||
1 34
|
||||
1 35
|
||||
1 36
|
||||
1 37
|
||||
1 38
|
||||
1 39
|
||||
1 40
|
||||
1 41
|
||||
1 42
|
||||
1 43
|
||||
1 44
|
||||
1 45
|
||||
1 46
|
||||
1 47
|
||||
1 48
|
||||
1 49
|
||||
1 50
|
||||
1 51
|
||||
1 52
|
||||
1 53
|
||||
1 54
|
||||
1 55
|
||||
1 56
|
||||
1 57
|
||||
1 58
|
||||
1 59
|
||||
1 60
|
||||
1 61
|
||||
1 62
|
||||
1 63
|
||||
1 64
|
||||
1 65
|
||||
1 66
|
||||
1 67
|
||||
1 68
|
||||
1 69
|
||||
1 70
|
||||
1 71
|
||||
1 72
|
||||
1 73
|
||||
1 74
|
||||
1 75
|
||||
1 76
|
||||
1 77
|
||||
1 78
|
||||
1 79
|
||||
1 80
|
||||
1 81
|
||||
1 82
|
||||
1 83
|
||||
1 84
|
||||
1 85
|
||||
1 86
|
||||
1 87
|
||||
1 88
|
||||
1 89
|
||||
1 90
|
||||
1 91
|
||||
1 92
|
||||
1 93
|
||||
1 94
|
||||
1 95
|
||||
1 96
|
||||
1 97
|
||||
1 98
|
||||
1 99
|
||||
1 100
|
||||
1 101
|
||||
1 102
|
||||
1 103
|
||||
1 104
|
||||
1 105
|
||||
1 106
|
||||
1 107
|
||||
1 108
|
||||
1 109
|
||||
1 110
|
||||
1 111
|
||||
1 112
|
||||
1 113
|
||||
1 114
|
||||
1 115
|
||||
1 116
|
||||
1 117
|
||||
1 118
|
||||
1 119
|
||||
1 120
|
||||
1 121
|
||||
1 122
|
||||
1 123
|
||||
1 124
|
||||
1 125
|
||||
1 126
|
||||
1 127
|
||||
1 128
|
||||
1 129
|
||||
1 130
|
||||
1 131
|
||||
1 132
|
||||
1 133
|
||||
1 134
|
||||
1 135
|
||||
1 136
|
||||
1 137
|
||||
1 138
|
||||
1 139
|
||||
1 140
|
||||
1 141
|
||||
1 142
|
||||
1 143
|
||||
1 144
|
||||
1 145
|
||||
1 146
|
||||
1 147
|
||||
1 148
|
||||
1 149
|
||||
1 150
|
||||
1 151
|
||||
1 152
|
||||
1 153
|
||||
1 154
|
||||
1 155
|
||||
1 156
|
||||
1 157
|
||||
1 158
|
||||
1 159
|
||||
1 160
|
||||
1 161
|
||||
1 162
|
||||
1 163
|
||||
1 164
|
||||
1 165
|
||||
1 166
|
||||
1 167
|
||||
1 168
|
||||
1 169
|
||||
1 170
|
||||
1 171
|
||||
1 172
|
||||
1 173
|
||||
1 174
|
||||
1 175
|
||||
1 176
|
||||
1 177
|
||||
1 178
|
||||
1 179
|
||||
1 180
|
||||
1 181
|
||||
1 182
|
||||
1 183
|
||||
1 184
|
||||
1 185
|
||||
1 186
|
||||
1 187
|
||||
1 188
|
||||
1 189
|
||||
1 190
|
||||
1 191
|
||||
1 192
|
||||
1 193
|
||||
1 194
|
||||
1 195
|
||||
1 196
|
||||
1 197
|
||||
1 198
|
||||
1 199
|
||||
1 200
|
||||
1 201
|
||||
1 202
|
||||
1 203
|
||||
1 204
|
||||
1 205
|
||||
1 206
|
||||
1 207
|
||||
1 208
|
||||
1 209
|
||||
1 210
|
||||
1 211
|
||||
1 212
|
||||
1 213
|
||||
1 214
|
||||
1 215
|
||||
1 216
|
||||
1 217
|
||||
1 218
|
||||
1 219
|
||||
1 220
|
||||
1 221
|
||||
1 222
|
||||
1 223
|
||||
1 224
|
||||
1 225
|
||||
1 226
|
||||
1 227
|
||||
1 228
|
||||
1 229
|
||||
1 230
|
||||
1 231
|
||||
1 232
|
||||
1 233
|
||||
1 234
|
||||
1 235
|
||||
1 236
|
||||
1 237
|
||||
1 238
|
||||
CELL_TYPES 239
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
6489
BasicSolver/2D-seq/vtk_files/particles70.vtk
Normal file
6489
BasicSolver/2D-seq/vtk_files/particles70.vtk
Normal file
File diff suppressed because it is too large
Load Diff
6669
BasicSolver/2D-seq/vtk_files/particles71.vtk
Normal file
6669
BasicSolver/2D-seq/vtk_files/particles71.vtk
Normal file
File diff suppressed because it is too large
Load Diff
6669
BasicSolver/2D-seq/vtk_files/particles72.vtk
Normal file
6669
BasicSolver/2D-seq/vtk_files/particles72.vtk
Normal file
File diff suppressed because it is too large
Load Diff
6849
BasicSolver/2D-seq/vtk_files/particles73.vtk
Normal file
6849
BasicSolver/2D-seq/vtk_files/particles73.vtk
Normal file
File diff suppressed because it is too large
Load Diff
6849
BasicSolver/2D-seq/vtk_files/particles74.vtk
Normal file
6849
BasicSolver/2D-seq/vtk_files/particles74.vtk
Normal file
File diff suppressed because it is too large
Load Diff
7029
BasicSolver/2D-seq/vtk_files/particles75.vtk
Normal file
7029
BasicSolver/2D-seq/vtk_files/particles75.vtk
Normal file
File diff suppressed because it is too large
Load Diff
7029
BasicSolver/2D-seq/vtk_files/particles76.vtk
Normal file
7029
BasicSolver/2D-seq/vtk_files/particles76.vtk
Normal file
File diff suppressed because it is too large
Load Diff
7209
BasicSolver/2D-seq/vtk_files/particles77.vtk
Normal file
7209
BasicSolver/2D-seq/vtk_files/particles77.vtk
Normal file
File diff suppressed because it is too large
Load Diff
7209
BasicSolver/2D-seq/vtk_files/particles78.vtk
Normal file
7209
BasicSolver/2D-seq/vtk_files/particles78.vtk
Normal file
File diff suppressed because it is too large
Load Diff
7389
BasicSolver/2D-seq/vtk_files/particles79.vtk
Normal file
7389
BasicSolver/2D-seq/vtk_files/particles79.vtk
Normal file
File diff suppressed because it is too large
Load Diff
729
BasicSolver/2D-seq/vtk_files/particles8.vtk
Normal file
729
BasicSolver/2D-seq/vtk_files/particles8.vtk
Normal file
@ -0,0 +1,729 @@
|
||||
# vtk DataFile Version 3.0
|
||||
PAMPI cfd solver particle tracing file
|
||||
ASCII
|
||||
DATASET UNSTRUCTURED_GRID
|
||||
FIELD FieldData 2
|
||||
TIME 1 1 double
|
||||
8
|
||||
CYCLE 1 1 int
|
||||
1
|
||||
POINTS 239 float
|
||||
1.00 4.00 0.0
|
||||
1.19 3.93 0.0
|
||||
1.38 3.87 0.0
|
||||
1.57 3.80 0.0
|
||||
1.75 3.73 0.0
|
||||
1.92 3.67 0.0
|
||||
2.08 3.60 0.0
|
||||
2.24 3.54 0.0
|
||||
2.38 3.47 0.0
|
||||
2.53 3.41 0.0
|
||||
2.66 3.34 0.0
|
||||
2.79 3.28 0.0
|
||||
2.90 3.21 0.0
|
||||
3.02 3.15 0.0
|
||||
3.12 3.08 0.0
|
||||
3.22 3.02 0.0
|
||||
3.31 2.96 0.0
|
||||
3.39 2.89 0.0
|
||||
3.47 2.83 0.0
|
||||
3.54 2.76 0.0
|
||||
3.60 2.69 0.0
|
||||
3.66 2.63 0.0
|
||||
3.71 2.56 0.0
|
||||
3.75 2.49 0.0
|
||||
3.78 2.42 0.0
|
||||
3.81 2.35 0.0
|
||||
3.83 2.27 0.0
|
||||
3.85 2.20 0.0
|
||||
3.86 2.13 0.0
|
||||
3.87 2.05 0.0
|
||||
3.87 1.98 0.0
|
||||
3.86 1.90 0.0
|
||||
3.85 1.83 0.0
|
||||
3.83 1.75 0.0
|
||||
3.81 1.68 0.0
|
||||
3.78 1.61 0.0
|
||||
3.74 1.54 0.0
|
||||
3.70 1.47 0.0
|
||||
3.65 1.40 0.0
|
||||
3.59 1.33 0.0
|
||||
3.53 1.26 0.0
|
||||
3.46 1.19 0.0
|
||||
3.38 1.13 0.0
|
||||
3.30 1.06 0.0
|
||||
3.21 0.99 0.0
|
||||
3.11 0.93 0.0
|
||||
3.00 0.86 0.0
|
||||
2.89 0.80 0.0
|
||||
2.77 0.73 0.0
|
||||
2.64 0.67 0.0
|
||||
2.51 0.60 0.0
|
||||
2.37 0.54 0.0
|
||||
2.22 0.47 0.0
|
||||
2.06 0.40 0.0
|
||||
1.90 0.34 0.0
|
||||
1.73 0.27 0.0
|
||||
1.56 0.20 0.0
|
||||
1.37 0.13 0.0
|
||||
1.18 0.07 0.0
|
||||
1.13 0.07 0.0
|
||||
1.00 4.00 0.0
|
||||
1.14 3.93 0.0
|
||||
1.28 3.87 0.0
|
||||
1.41 3.80 0.0
|
||||
1.54 3.73 0.0
|
||||
1.66 3.67 0.0
|
||||
1.78 3.60 0.0
|
||||
1.89 3.53 0.0
|
||||
2.00 3.47 0.0
|
||||
2.10 3.40 0.0
|
||||
2.20 3.33 0.0
|
||||
2.29 3.27 0.0
|
||||
2.38 3.20 0.0
|
||||
2.46 3.13 0.0
|
||||
2.54 3.07 0.0
|
||||
2.61 3.00 0.0
|
||||
2.68 2.93 0.0
|
||||
2.74 2.87 0.0
|
||||
2.79 2.80 0.0
|
||||
2.85 2.73 0.0
|
||||
2.89 2.66 0.0
|
||||
2.94 2.60 0.0
|
||||
2.97 2.53 0.0
|
||||
3.01 2.46 0.0
|
||||
3.03 2.39 0.0
|
||||
3.06 2.32 0.0
|
||||
3.07 2.25 0.0
|
||||
3.09 2.18 0.0
|
||||
3.10 2.11 0.0
|
||||
3.10 2.04 0.0
|
||||
3.10 1.97 0.0
|
||||
3.10 1.90 0.0
|
||||
3.09 1.83 0.0
|
||||
3.07 1.76 0.0
|
||||
3.05 1.69 0.0
|
||||
3.03 1.62 0.0
|
||||
3.00 1.55 0.0
|
||||
2.97 1.49 0.0
|
||||
2.93 1.42 0.0
|
||||
2.89 1.35 0.0
|
||||
2.84 1.28 0.0
|
||||
2.79 1.21 0.0
|
||||
2.73 1.14 0.0
|
||||
2.67 1.08 0.0
|
||||
2.60 1.01 0.0
|
||||
2.53 0.94 0.0
|
||||
2.45 0.88 0.0
|
||||
2.37 0.81 0.0
|
||||
2.28 0.74 0.0
|
||||
2.19 0.67 0.0
|
||||
2.09 0.61 0.0
|
||||
1.99 0.54 0.0
|
||||
1.88 0.47 0.0
|
||||
1.77 0.40 0.0
|
||||
1.65 0.34 0.0
|
||||
1.53 0.27 0.0
|
||||
1.40 0.20 0.0
|
||||
1.27 0.13 0.0
|
||||
1.13 0.07 0.0
|
||||
1.00 0.00 0.0
|
||||
1.00 4.00 0.0
|
||||
1.08 3.93 0.0
|
||||
1.17 3.87 0.0
|
||||
1.25 3.80 0.0
|
||||
1.33 3.73 0.0
|
||||
1.41 3.66 0.0
|
||||
1.48 3.60 0.0
|
||||
1.55 3.53 0.0
|
||||
1.62 3.46 0.0
|
||||
1.68 3.39 0.0
|
||||
1.74 3.33 0.0
|
||||
1.80 3.26 0.0
|
||||
1.85 3.19 0.0
|
||||
1.90 3.13 0.0
|
||||
1.95 3.06 0.0
|
||||
1.99 2.99 0.0
|
||||
2.04 2.92 0.0
|
||||
2.08 2.86 0.0
|
||||
2.11 2.79 0.0
|
||||
2.14 2.72 0.0
|
||||
2.17 2.65 0.0
|
||||
2.20 2.58 0.0
|
||||
2.22 2.52 0.0
|
||||
2.24 2.45 0.0
|
||||
2.26 2.38 0.0
|
||||
2.28 2.31 0.0
|
||||
2.29 2.24 0.0
|
||||
2.30 2.18 0.0
|
||||
2.30 2.11 0.0
|
||||
2.31 2.04 0.0
|
||||
2.30 1.97 0.0
|
||||
2.30 1.90 0.0
|
||||
2.30 1.83 0.0
|
||||
2.29 1.76 0.0
|
||||
2.27 1.70 0.0
|
||||
2.26 1.63 0.0
|
||||
2.24 1.56 0.0
|
||||
2.22 1.49 0.0
|
||||
2.20 1.42 0.0
|
||||
2.17 1.36 0.0
|
||||
2.14 1.29 0.0
|
||||
2.11 1.22 0.0
|
||||
2.07 1.15 0.0
|
||||
2.03 1.08 0.0
|
||||
1.99 1.02 0.0
|
||||
1.94 0.95 0.0
|
||||
1.90 0.88 0.0
|
||||
1.85 0.81 0.0
|
||||
1.79 0.74 0.0
|
||||
1.73 0.68 0.0
|
||||
1.67 0.61 0.0
|
||||
1.61 0.54 0.0
|
||||
1.54 0.47 0.0
|
||||
1.47 0.41 0.0
|
||||
1.40 0.34 0.0
|
||||
1.33 0.27 0.0
|
||||
1.25 0.20 0.0
|
||||
1.17 0.13 0.0
|
||||
1.08 0.07 0.0
|
||||
1.00 0.00 0.0
|
||||
1.00 4.00 0.0
|
||||
1.03 3.93 0.0
|
||||
1.06 3.87 0.0
|
||||
1.10 3.80 0.0
|
||||
1.13 3.73 0.0
|
||||
1.15 3.66 0.0
|
||||
1.18 3.59 0.0
|
||||
1.21 3.53 0.0
|
||||
1.23 3.46 0.0
|
||||
1.26 3.39 0.0
|
||||
1.28 3.32 0.0
|
||||
1.30 3.26 0.0
|
||||
1.32 3.19 0.0
|
||||
1.34 3.12 0.0
|
||||
1.36 3.05 0.0
|
||||
1.38 2.99 0.0
|
||||
1.39 2.92 0.0
|
||||
1.41 2.85 0.0
|
||||
1.42 2.78 0.0
|
||||
1.43 2.71 0.0
|
||||
1.45 2.65 0.0
|
||||
1.46 2.58 0.0
|
||||
1.46 2.51 0.0
|
||||
1.47 2.44 0.0
|
||||
1.48 2.37 0.0
|
||||
1.48 2.31 0.0
|
||||
1.49 2.24 0.0
|
||||
1.49 2.17 0.0
|
||||
1.49 2.10 0.0
|
||||
1.50 2.04 0.0
|
||||
1.50 1.97 0.0
|
||||
1.49 1.90 0.0
|
||||
1.49 1.83 0.0
|
||||
1.49 1.76 0.0
|
||||
1.48 1.70 0.0
|
||||
1.48 1.63 0.0
|
||||
1.47 1.56 0.0
|
||||
1.46 1.49 0.0
|
||||
1.45 1.42 0.0
|
||||
1.44 1.36 0.0
|
||||
1.43 1.29 0.0
|
||||
1.42 1.22 0.0
|
||||
1.41 1.15 0.0
|
||||
1.39 1.08 0.0
|
||||
1.38 1.02 0.0
|
||||
1.36 0.95 0.0
|
||||
1.34 0.88 0.0
|
||||
1.32 0.81 0.0
|
||||
1.30 0.75 0.0
|
||||
1.28 0.68 0.0
|
||||
1.26 0.61 0.0
|
||||
1.23 0.54 0.0
|
||||
1.21 0.47 0.0
|
||||
1.18 0.41 0.0
|
||||
1.15 0.34 0.0
|
||||
1.12 0.27 0.0
|
||||
1.09 0.20 0.0
|
||||
1.06 0.14 0.0
|
||||
1.03 0.07 0.0
|
||||
CELLS 239 478
|
||||
1 0
|
||||
1 1
|
||||
1 2
|
||||
1 3
|
||||
1 4
|
||||
1 5
|
||||
1 6
|
||||
1 7
|
||||
1 8
|
||||
1 9
|
||||
1 10
|
||||
1 11
|
||||
1 12
|
||||
1 13
|
||||
1 14
|
||||
1 15
|
||||
1 16
|
||||
1 17
|
||||
1 18
|
||||
1 19
|
||||
1 20
|
||||
1 21
|
||||
1 22
|
||||
1 23
|
||||
1 24
|
||||
1 25
|
||||
1 26
|
||||
1 27
|
||||
1 28
|
||||
1 29
|
||||
1 30
|
||||
1 31
|
||||
1 32
|
||||
1 33
|
||||
1 34
|
||||
1 35
|
||||
1 36
|
||||
1 37
|
||||
1 38
|
||||
1 39
|
||||
1 40
|
||||
1 41
|
||||
1 42
|
||||
1 43
|
||||
1 44
|
||||
1 45
|
||||
1 46
|
||||
1 47
|
||||
1 48
|
||||
1 49
|
||||
1 50
|
||||
1 51
|
||||
1 52
|
||||
1 53
|
||||
1 54
|
||||
1 55
|
||||
1 56
|
||||
1 57
|
||||
1 58
|
||||
1 59
|
||||
1 60
|
||||
1 61
|
||||
1 62
|
||||
1 63
|
||||
1 64
|
||||
1 65
|
||||
1 66
|
||||
1 67
|
||||
1 68
|
||||
1 69
|
||||
1 70
|
||||
1 71
|
||||
1 72
|
||||
1 73
|
||||
1 74
|
||||
1 75
|
||||
1 76
|
||||
1 77
|
||||
1 78
|
||||
1 79
|
||||
1 80
|
||||
1 81
|
||||
1 82
|
||||
1 83
|
||||
1 84
|
||||
1 85
|
||||
1 86
|
||||
1 87
|
||||
1 88
|
||||
1 89
|
||||
1 90
|
||||
1 91
|
||||
1 92
|
||||
1 93
|
||||
1 94
|
||||
1 95
|
||||
1 96
|
||||
1 97
|
||||
1 98
|
||||
1 99
|
||||
1 100
|
||||
1 101
|
||||
1 102
|
||||
1 103
|
||||
1 104
|
||||
1 105
|
||||
1 106
|
||||
1 107
|
||||
1 108
|
||||
1 109
|
||||
1 110
|
||||
1 111
|
||||
1 112
|
||||
1 113
|
||||
1 114
|
||||
1 115
|
||||
1 116
|
||||
1 117
|
||||
1 118
|
||||
1 119
|
||||
1 120
|
||||
1 121
|
||||
1 122
|
||||
1 123
|
||||
1 124
|
||||
1 125
|
||||
1 126
|
||||
1 127
|
||||
1 128
|
||||
1 129
|
||||
1 130
|
||||
1 131
|
||||
1 132
|
||||
1 133
|
||||
1 134
|
||||
1 135
|
||||
1 136
|
||||
1 137
|
||||
1 138
|
||||
1 139
|
||||
1 140
|
||||
1 141
|
||||
1 142
|
||||
1 143
|
||||
1 144
|
||||
1 145
|
||||
1 146
|
||||
1 147
|
||||
1 148
|
||||
1 149
|
||||
1 150
|
||||
1 151
|
||||
1 152
|
||||
1 153
|
||||
1 154
|
||||
1 155
|
||||
1 156
|
||||
1 157
|
||||
1 158
|
||||
1 159
|
||||
1 160
|
||||
1 161
|
||||
1 162
|
||||
1 163
|
||||
1 164
|
||||
1 165
|
||||
1 166
|
||||
1 167
|
||||
1 168
|
||||
1 169
|
||||
1 170
|
||||
1 171
|
||||
1 172
|
||||
1 173
|
||||
1 174
|
||||
1 175
|
||||
1 176
|
||||
1 177
|
||||
1 178
|
||||
1 179
|
||||
1 180
|
||||
1 181
|
||||
1 182
|
||||
1 183
|
||||
1 184
|
||||
1 185
|
||||
1 186
|
||||
1 187
|
||||
1 188
|
||||
1 189
|
||||
1 190
|
||||
1 191
|
||||
1 192
|
||||
1 193
|
||||
1 194
|
||||
1 195
|
||||
1 196
|
||||
1 197
|
||||
1 198
|
||||
1 199
|
||||
1 200
|
||||
1 201
|
||||
1 202
|
||||
1 203
|
||||
1 204
|
||||
1 205
|
||||
1 206
|
||||
1 207
|
||||
1 208
|
||||
1 209
|
||||
1 210
|
||||
1 211
|
||||
1 212
|
||||
1 213
|
||||
1 214
|
||||
1 215
|
||||
1 216
|
||||
1 217
|
||||
1 218
|
||||
1 219
|
||||
1 220
|
||||
1 221
|
||||
1 222
|
||||
1 223
|
||||
1 224
|
||||
1 225
|
||||
1 226
|
||||
1 227
|
||||
1 228
|
||||
1 229
|
||||
1 230
|
||||
1 231
|
||||
1 232
|
||||
1 233
|
||||
1 234
|
||||
1 235
|
||||
1 236
|
||||
1 237
|
||||
1 238
|
||||
CELL_TYPES 239
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
||||
1
|
7389
BasicSolver/2D-seq/vtk_files/particles80.vtk
Normal file
7389
BasicSolver/2D-seq/vtk_files/particles80.vtk
Normal file
File diff suppressed because it is too large
Load Diff
7569
BasicSolver/2D-seq/vtk_files/particles81.vtk
Normal file
7569
BasicSolver/2D-seq/vtk_files/particles81.vtk
Normal file
File diff suppressed because it is too large
Load Diff
7569
BasicSolver/2D-seq/vtk_files/particles82.vtk
Normal file
7569
BasicSolver/2D-seq/vtk_files/particles82.vtk
Normal file
File diff suppressed because it is too large
Load Diff
7749
BasicSolver/2D-seq/vtk_files/particles83.vtk
Normal file
7749
BasicSolver/2D-seq/vtk_files/particles83.vtk
Normal file
File diff suppressed because it is too large
Load Diff
7749
BasicSolver/2D-seq/vtk_files/particles84.vtk
Normal file
7749
BasicSolver/2D-seq/vtk_files/particles84.vtk
Normal file
File diff suppressed because it is too large
Load Diff
Some files were not shown because too many files have changed in this diff Show More
Loading…
x
Reference in New Issue
Block a user