Skip to content
GitLab
Menu
Projects
Groups
Snippets
Help
Help
Support
Community forum
Keyboard shortcuts
?
Submit feedback
Sign in
Toggle navigation
Menu
Open sidebar
KiT-RT
KiT-RT
Commits
96ad94b5
Commit
96ad94b5
authored
Jan 16, 2021
by
jannick.wolters
Browse files
merged current master
Former-commit-id:
a54b06bb
parents
2360c430
7590242d
Changes
56
Hide whitespace changes
Inline
Side-by-side
code/src/solvers/pnsolver.cpp
View file @
96ad94b5
#include "solvers/pnsolver.h"
#include "common/config.h"
#include "common/io.h"
#include "common/mesh.h"
#include "fluxes/numericalflux.h"
#include "toolboxes/errormessages.h"
#include "toolboxes/textprocessingtoolbox.h"
...
...
@@ -31,6 +32,10 @@ PNSolver::PNSolver( Config* settings ) : Solver( settings ) {
// Initialize Scatter Matrix
_scatterMatDiag
=
Vector
(
_nTotalEntries
,
0
);
// Initialize temporary storages of solution derivatives
_solDx
=
VectorVector
(
_nCells
,
Vector
(
_nTotalEntries
,
0.0
)
);
_solDy
=
VectorVector
(
_nCells
,
Vector
(
_nTotalEntries
,
0.0
)
);
// Fill System Matrices
ComputeSystemMatrices
();
...
...
@@ -71,6 +76,15 @@ void PNSolver::ComputeRadFlux() {
}
void
PNSolver
::
FluxUpdate
()
{
if
(
_reconsOrder
>
1
)
{
_mesh
->
ReconstructSlopesU
(
_nTotalEntries
,
_solDx
,
_solDy
,
_sol
);
// unstructured reconstruction
//_mesh->ComputeSlopes( _nTotalEntries, _solDx, _solDy, _sol ); // unstructured reconstruction
}
//Vector solL( _nTotalEntries );
//Vector solR( _nTotalEntries );
auto
solL
=
_sol
[
2
];
auto
solR
=
_sol
[
2
];
// Loop over all spatial cells
for
(
unsigned
idx_cell
=
0
;
idx_cell
<
_nCells
;
idx_cell
++
)
{
...
...
@@ -89,16 +103,60 @@ void PNSolver::FluxUpdate() {
if
(
_boundaryCells
[
idx_cell
]
==
BOUNDARY_TYPE
::
NEUMANN
&&
_neighbors
[
idx_cell
][
idx_neighbor
]
==
_nCells
)
_solNew
[
idx_cell
]
+=
_g
->
Flux
(
_AxPlus
,
_AxMinus
,
_AyPlus
,
_AyMinus
,
_AzPlus
,
_AzMinus
,
_sol
[
idx_cell
],
_sol
[
idx_cell
],
_normals
[
idx_cell
][
idx_neighbor
]
);
else
_solNew
[
idx_cell
]
+=
_g
->
Flux
(
_AxPlus
,
_AxMinus
,
_AyPlus
,
_AyMinus
,
_AzPlus
,
_AzMinus
,
_sol
[
idx_cell
],
_sol
[
_neighbors
[
idx_cell
][
idx_neighbor
]],
_normals
[
idx_cell
][
idx_neighbor
]
);
else
{
switch
(
_reconsOrder
)
{
// first order solver
case
1
:
_solNew
[
idx_cell
]
+=
_g
->
Flux
(
_AxPlus
,
_AxMinus
,
_AyPlus
,
_AyMinus
,
_AzPlus
,
_AzMinus
,
_sol
[
idx_cell
],
_sol
[
_neighbors
[
idx_cell
][
idx_neighbor
]],
_normals
[
idx_cell
][
idx_neighbor
]
);
break
;
// second order solver
case
2
:
// left status of interface
solL
=
_sol
[
idx_cell
]
+
_solDx
[
idx_cell
]
*
(
_interfaceMidPoints
[
idx_cell
][
idx_neighbor
][
0
]
-
_cellMidPoints
[
idx_cell
][
0
]
)
+
_solDy
[
idx_cell
]
*
(
_interfaceMidPoints
[
idx_cell
][
idx_neighbor
][
1
]
-
_cellMidPoints
[
idx_cell
][
1
]
);
// right status of interface
solR
=
_sol
[
_neighbors
[
idx_cell
][
idx_neighbor
]]
+
_solDx
[
_neighbors
[
idx_cell
][
idx_neighbor
]]
*
(
_interfaceMidPoints
[
idx_cell
][
idx_neighbor
][
0
]
-
_cellMidPoints
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
0
]
)
+
_solDy
[
_neighbors
[
idx_cell
][
idx_neighbor
]]
*
(
_interfaceMidPoints
[
idx_cell
][
idx_neighbor
][
1
]
-
_cellMidPoints
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
1
]
);
// positivity checker (if not satisfied, deduce to first order)
// I manually turned it off here since Pn produces negative solutions essentially
//if( min(solL) < 0.0 || min(solR) < 0.0 ) {
// solL = _sol[idx_cell];
// solR = _sol[_neighbors[idx_cell][idx_neighbor]];
//}
// flux evaluation
_solNew
[
idx_cell
]
+=
_g
->
Flux
(
_AxPlus
,
_AxMinus
,
_AyPlus
,
_AyMinus
,
_AzPlus
,
_AzMinus
,
solL
,
solR
,
_normals
[
idx_cell
][
idx_neighbor
]
);
break
;
// default: first order solver
default:
_solNew
[
idx_cell
]
+=
_g
->
Flux
(
_AxPlus
,
_AxMinus
,
_AyPlus
,
_AyMinus
,
_AzPlus
,
_AzMinus
,
_sol
[
idx_cell
],
_sol
[
_neighbors
[
idx_cell
][
idx_neighbor
]],
_normals
[
idx_cell
][
idx_neighbor
]
);
}
}
}
}
}
...
...
code/src/solvers/snsolver.cpp
View file @
96ad94b5
...
...
@@ -55,7 +55,6 @@ void SNSolver::FluxUpdate() {
// left and right angular flux of interface, used in numerical flux evaluation
double psiL;
double psiR;
double mass;
// derivatives of angular flux in x and y directions
VectorVector psiDx( _nCells, Vector( _nq, 0.0 ) );
...
...
@@ -98,7 +97,12 @@ void SNSolver::FluxUpdate() {
//_mesh->ReconstructSlopesS( _nq, psiDx, psiDy, _psi ); // structured reconstruction (not stable currently)
}
*/
if
(
_reconsOrder
>
1
)
{
_mesh
->
ReconstructSlopesU
(
_nq
,
_psiDx
,
_psiDy
,
_sol
);
// unstructured reconstruction
//_mesh->ReconstructSlopesS( _nq, _psiDx, _psiDy, _psi ); // structured reconstruction (not stable currently)
}
double
psiL
;
double
psiR
;
// Loop over all spatial cells
for
(
unsigned
idx_cell
=
0
;
idx_cell
<
_nCells
;
++
idx_cell
)
{
// Dirichlet cells stay at IC, farfield assumption
...
...
@@ -114,45 +118,40 @@ void SNSolver::FluxUpdate() {
_solNew
[
idx_cell
][
idx_quad
]
+=
_g
->
Flux
(
_quadPoints
[
idx_quad
],
_sol
[
idx_cell
][
idx_quad
],
_sol
[
idx_cell
][
idx_quad
],
_normals
[
idx_cell
][
idx_neighbor
]
);
else
{
/* switch( reconsOrder ) {
// first order solver
case 1:
psiNew[idx_cells][idx_quad] += _g->Flux( _quadPoints[idx_quad],
_sol[idx_cells][idx_quad],
_sol[_neighbors[idx_cells][idx_neighbor]][idx_quad],
_normals[idx_cells][idx_neighbor] );
break;
// second order solver
case 2:
// left status of interface
psiL = _sol[idx_cells][idx_quad] +
psiDx[idx_cells][idx_quad] * ( interfaceMidPoints[idx_cells][idx_neighbor][0] -
cellMidPoints[idx_cells][0] ) + psiDy[idx_cells][idx_quad] * ( interfaceMidPoints[idx_cells][idx_neighbor][1] -
cellMidPoints[idx_cells][1] );
// right status of interface
psiR = _sol[_neighbors[idx_cells][idx_neighbor]][idx_quad] +
psiDx[_neighbors[idx_cells][idx_neighbor]][idx_quad] *
( interfaceMidPoints[idx_cells][idx_neighbor][0] -
cellMidPoints[_neighbors[idx_cells][idx_neighbor]][0] ) + psiDy[_neighbors[idx_cells][idx_neighbor]][idx_quad] * (
interfaceMidPoints[idx_cells][idx_neighbor][1] - cellMidPoints[_neighbors[idx_cells][idx_neighbor]][1] );
// positivity check (if not satisfied, deduce to first order)
if( psiL < 0.0 || psiR < 0.0 ) {
psiL = _sol[idx_cells][idx_quad];
psiR = _sol[_neighbors[idx_cells][idx_neighbor]][idx_quad];
}
// flux evaluation
psiNew[idx_cells][idx_quad] += _g->Flux( _quadPoints[idx_quad], psiL, psiR,
_normals[idx_cells][idx_neighbor] ); break;
// higher order solver
case 3: std::cout << "higher order is WIP" << std::endl; break;
// default: first order solver
default:
*/
_solNew
[
idx_cell
][
idx_quad
]
+=
_g
->
Flux
(
_quadPoints
[
idx_quad
],
_sol
[
idx_cell
][
idx_quad
],
_sol
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
idx_quad
],
_normals
[
idx_cell
][
idx_neighbor
]
);
// }
switch
(
_reconsOrder
)
{
// first order solver
case
1
:
_solNew
[
idx_cell
][
idx_quad
]
+=
_g
->
Flux
(
_quadPoints
[
idx_quad
],
_sol
[
idx_cell
][
idx_quad
],
_sol
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
idx_quad
],
_normals
[
idx_cell
][
idx_neighbor
]
);
break
;
// second order solver
case
2
:
// left status of interface
psiL
=
_sol
[
idx_cell
][
idx_quad
]
+
_psiDx
[
idx_cell
][
idx_quad
]
*
(
_interfaceMidPoints
[
idx_cell
][
idx_neighbor
][
0
]
-
_cellMidPoints
[
idx_cell
][
0
]
)
+
_psiDy
[
idx_cell
][
idx_quad
]
*
(
_interfaceMidPoints
[
idx_cell
][
idx_neighbor
][
1
]
-
_cellMidPoints
[
idx_cell
][
1
]
);
// right status of interface
psiR
=
_sol
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
idx_quad
]
+
_psiDx
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
idx_quad
]
*
(
_interfaceMidPoints
[
idx_cell
][
idx_neighbor
][
0
]
-
_cellMidPoints
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
0
]
)
+
_psiDy
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
idx_quad
]
*
(
_interfaceMidPoints
[
idx_cell
][
idx_neighbor
][
1
]
-
_cellMidPoints
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
1
]
);
// positivity check (if not satisfied, deduce to first order)
if
(
psiL
<
0.0
||
psiR
<
0.0
)
{
psiL
=
_sol
[
idx_cell
][
idx_quad
];
psiR
=
_sol
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
idx_quad
];
}
// flux evaluation
_solNew
[
idx_cell
][
idx_quad
]
+=
_g
->
Flux
(
_quadPoints
[
idx_quad
],
psiL
,
psiR
,
_normals
[
idx_cell
][
idx_neighbor
]
);
break
;
// higher order solver
case
3
:
std
::
cout
<<
"higher order is WIP"
<<
std
::
endl
;
break
;
// default: first order solver
default:
_solNew
[
idx_cell
][
idx_quad
]
+=
_g
->
Flux
(
_quadPoints
[
idx_quad
],
_sol
[
idx_cell
][
idx_quad
],
_sol
[
_neighbors
[
idx_cell
][
idx_neighbor
]][
idx_quad
],
_normals
[
idx_cell
][
idx_neighbor
]
);
}
}
}
}
...
...
code/src/solvers/solverbase.cpp
View file @
96ad94b5
...
...
@@ -25,10 +25,32 @@ Solver::Solver( Config* settings ) : _settings( settings ) {
_settings
->
SetNCells
(
_nCells
);
// build quadrature object and store frequently used params
_quadrature
=
QuadratureBase
::
Create
Quadrature
(
settings
);
_quadrature
=
QuadratureBase
::
Create
(
settings
);
_nq
=
_quadrature
->
GetNq
();
_settings
->
SetNQuadPoints
(
_nq
);
// build slope related params
_reconstructor
=
Reconstructor
::
Create
(
settings
);
_reconsOrder
=
_reconstructor
->
GetReconsOrder
();
auto
nodes
=
_mesh
->
GetNodes
();
auto
cells
=
_mesh
->
GetCells
();
std
::
vector
<
std
::
vector
<
Vector
>>
interfaceMidPoints
(
_nCells
,
std
::
vector
<
Vector
>
(
_mesh
->
GetNumNodesPerCell
(),
Vector
(
2
,
1e-10
)
)
);
for
(
unsigned
idx_cell
=
0
;
idx_cell
<
_nCells
;
++
idx_cell
)
{
for
(
unsigned
k
=
0
;
k
<
_mesh
->
GetDim
();
++
k
)
{
for
(
unsigned
j
=
0
;
j
<
_neighbors
[
idx_cell
].
size
()
-
1
;
++
j
)
{
interfaceMidPoints
[
idx_cell
][
j
][
k
]
=
0.5
*
(
nodes
[
cells
[
idx_cell
][
j
]][
k
]
+
nodes
[
cells
[
idx_cell
][
j
+
1
]][
k
]
);
}
interfaceMidPoints
[
idx_cell
][
_neighbors
[
idx_cell
].
size
()
-
1
][
k
]
=
0.5
*
(
nodes
[
cells
[
idx_cell
][
_neighbors
[
idx_cell
].
size
()
-
1
]][
k
]
+
nodes
[
cells
[
idx_cell
][
0
]][
k
]
);
}
}
_interfaceMidPoints
=
interfaceMidPoints
;
_cellMidPoints
=
_mesh
->
GetCellMidPoints
();
_psiDx
=
VectorVector
(
_nCells
,
Vector
(
_nq
,
0.0
)
);
_psiDy
=
VectorVector
(
_nCells
,
Vector
(
_nq
,
0.0
)
);
// set time step
_dE
=
ComputeTimeStep
(
settings
->
GetCFL
()
);
_nEnergies
=
unsigned
(
settings
->
GetTEnd
()
/
_dE
);
...
...
code/src/toolboxes/interpolation.cpp
View file @
96ad94b5
...
...
@@ -91,19 +91,19 @@ double Interpolation::operator()( double x, double y ) const {
if
(
_type
==
cubic
)
{
// find closest values to x and y in table (lower bounds)
unsigned
xId
=
IndexOfClosestValue
(
x
,
_x
);
unsigned
yId
=
IndexOfClosestValue
(
y
,
_y
);
int
xId
=
IndexOfClosestValue
(
x
,
_x
);
int
yId
=
IndexOfClosestValue
(
y
,
_y
);
// store all 16 interpolation points needed
double
points
[
4
][
4
];
for
(
int
i
=
-
1
;
i
<
3
;
++
i
)
{
unsigned
idx_y
;
idx_y
=
yId
+
i
<
0
?
0
:
yId
+
i
;
idx_y
=
yId
+
i
>
_data
.
rows
()
-
1
?
_data
.
rows
()
-
1
:
yId
+
i
;
idx_y
=
yId
+
i
>
static_cast
<
int
>
(
_data
.
rows
()
-
1
)
?
_data
.
rows
()
-
1
:
yId
+
i
;
for
(
int
j
=
-
1
;
j
<
3
;
++
j
)
{
unsigned
idx_x
;
idx_x
=
xId
+
j
<
0
?
0
:
xId
+
j
;
idx_x
=
xId
+
j
>
_data
.
columns
()
-
1
?
_data
.
columns
()
-
1
:
xId
+
j
;
idx_x
=
xId
+
j
>
static_cast
<
int
>
(
_data
.
columns
()
-
1
)
?
_data
.
columns
()
-
1
:
xId
+
j
;
points
[
i
+
1
][
j
+
1
]
=
_data
(
idx_x
,
idx_y
);
}
...
...
code/src/toolboxes/reconstructor.cpp
View file @
96ad94b5
#include "toolboxes/reconstructor.h"
#include "common/config.h"
Reconstructor
::
Reconstructor
(
Config
*
settings
)
{}
Reconstructor
::
Reconstructor
(
Config
*
settings
)
{
_reconsOrder
=
settings
->
GetReconsOrder
();
}
Reconstructor
*
Reconstructor
::
Create
(
Config
*
settings
)
{
return
new
Reconstructor
(
settings
);
}
double
FortSign
(
double
a
,
double
b
)
{
if
(
b
>
0.0
)
return
abs
(
a
);
if
(
b
<
0.0
)
return
-
abs
(
a
);
if
(
b
>
0.0
)
return
std
::
f
abs
(
a
);
if
(
b
<
0.0
)
return
-
std
::
f
abs
(
a
);
return
0.0
;
}
double
LMinMod
(
double
sL
,
double
sR
)
{
return
0.5
*
(
FortSign
(
1.0
,
sL
)
+
FortSign
(
1.
,
sR
)
)
*
fmin
(
abs
(
sL
),
abs
(
sR
)
);
}
double
LMinMod
(
double
sL
,
double
sR
)
{
return
0.5
*
(
FortSign
(
1.0
,
sL
)
+
FortSign
(
1.
,
sR
)
)
*
fmin
(
std
::
f
abs
(
sL
),
std
::
f
abs
(
sR
)
);
}
double
LVanLeer
(
double
sL
,
double
sR
)
{
return
(
FortSign
(
1.0
,
sL
)
+
FortSign
(
1.0
,
sR
)
)
*
abs
(
sL
)
*
abs
(
sR
)
/
(
abs
(
sL
)
+
abs
(
sR
)
+
0.0000001
);
return
(
FortSign
(
1.0
,
sL
)
+
FortSign
(
1.0
,
sR
)
)
*
std
::
f
abs
(
sL
)
*
std
::
f
abs
(
sR
)
/
(
std
::
f
abs
(
sL
)
+
std
::
f
abs
(
sR
)
+
0.0000001
);
}
double
LSuperBee
(
double
sL
,
double
sR
)
{
if
(
sR
>=
0.5
*
sL
&&
sR
<=
2.0
*
sL
)
return
0.5
*
(
FortSign
(
1.0
,
sL
)
+
FortSign
(
1.
,
sR
)
)
*
fmax
(
abs
(
sL
),
abs
(
sR
)
);
if
(
sR
<
0.5
*
sL
&&
sR
>
2.0
*
sL
)
return
(
FortSign
(
1.0
,
sL
)
+
FortSign
(
1.
,
sR
)
)
*
fmin
(
abs
(
sL
),
abs
(
sR
)
);
if
(
sR
>=
0.5
*
sL
&&
sR
<=
2.0
*
sL
)
return
0.5
*
(
FortSign
(
1.0
,
sL
)
+
FortSign
(
1.
,
sR
)
)
*
fmax
(
std
::
f
abs
(
sL
),
std
::
f
abs
(
sR
)
);
if
(
sR
<
0.5
*
sL
&&
sR
>
2.0
*
sL
)
return
(
FortSign
(
1.0
,
sL
)
+
FortSign
(
1.
,
sR
)
)
*
fmin
(
std
::
f
abs
(
sL
),
std
::
f
abs
(
sR
)
);
return
0.0
;
}
double
LVanAlbaba
(
double
sL
,
double
sR
)
{
return
(
sL
*
sL
*
sR
+
sL
*
sR
*
sR
)
/
(
sL
*
sL
+
sR
*
sR
+
0.0000001
);
}
double
LWENOJS
(
double
x
)
{
return
0.0
;
}
double
LWENOJS
(
double
/*x*/
)
{
return
0.0
;
}
double
Reconstructor
::
ReconstructSlopeStruct
(
double
uL
,
double
uC
,
double
uR
,
double
dxL
,
double
dxR
,
std
::
string
limiter
)
const
{
double
sL
=
(
uC
-
uL
)
/
dxL
;
...
...
code/src/
solver
s/sphericalharmonics.cpp
→
code/src/
toolboxe
s/sphericalharmonics.cpp
View file @
96ad94b5
#include "
solver
s/sphericalharmonics.h"
#include "
toolboxe
s/sphericalharmonics.h"
#include <math.h>
SphericalHarmonics
::
SphericalHarmonics
(
unsigned
L_degree
)
{
...
...
code/tests/input/validation_tests/MN_solver/checkerboard_MN.cfg
View file @
96ad94b5
...
...
@@ -18,7 +18,7 @@ PROBLEM = CHECKERBOARD
% ---- Solver specifications ----
%
CFL_NUMBER = 0.5
TIME_FINAL =
3.2
TIME_FINAL =
0.4
SOLVER = MN_SOLVER
MAX_MOMENT_SOLVER = 2
ENTROPY_FUNCTIONAL = MAXWELL_BOLTZMANN
...
...
code/tests/input/validation_tests/MN_solver/checkerboard_MN_reference.vtk
View file @
96ad94b5
...
...
@@ -2320,23 +2320,23 @@ radiation%20flux%20density 1 1056 double
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
0.012884029418 0.01332198066 -0.001175354229 -0.001175354229 -0.001175354229 0.046722187509 0.0022378573236 -0.001175354229 0.041608308258
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 0.008281290878 -0.001175354229 -0.001175354229 -0.001175354229
0.0047775072362 -0.001175354229 0.0046949706315 -0.001175354229 0.0050999772269 -0.001175354229 -0.001175354229 -0.001175354229 0.012885237389
0.01347064903 -0.001175354229 0.04639207685 0.041579672744 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 0.0026810318544
-0.001175354229 -0.001175354229 0.0082830531229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 0.0047516101692
0.0056955650474 -0.001175354229 0.0046994404757 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 0.85204988839 0.85199638633 0.68980279598 0.68927947887 0.67087477349 0.66912582908
0.61272173232 0.61213831452 0.6133534161 0.61369427875 0.6136185249 0.61200216845 0.61285461689 0.61342925303 0.73606817489
0.73601944613 0.73626518573 0.73582185697 0.79138406505 0.79131698612 0.79107835712 0.79101095225 0.72915753834 0.7280089701
0.72911194046 0.72805502925 -0.001175354229 -0.0038733217722 0.016039733942 -0.001175354229 -0.001175354229 0.01052228751 -0.001175354229
-0.0011257638221 0.0022189461361 -0.001175354229 0.040778283178 -0.001175354229 0.040194665944 -0.001175354229 -0.001175354229 0.0098347709769
-0.001175354229 0.011667877157 -0.001175354229 -0.005059381161 -0.001175354229 0.012829021376 0.0064114630433 -0.001175354229 -0.001175354229
0.012641862507 -0.0039070363941 -0.001175354229 -0.001175354229 0.012055467489 -0.001175354229 0.010471596771 -0.001175354229 -0.001175354229
0.0026175353195 0.040758620814 0.0022389643141 -0.001175354229 -0.001175354229 0.039831961741 -0.001175354229 -0.001175354229 -0.001175354229
0.014059824509 -0.001175354229 -0.001175354229 0.012785943198 -0.001175354229 -0.001175354229 -0.001175354229 0.0065130215447 0.012626577153
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 0.32218118677 0.32218118677 0.27929540709 0.27926629057 0.27270276389 0.2727027643
0.26227966045 0.26227966026 0.26227966063 0.26227966014 0.26227966035 0.26227966054 0.26227966005 0.26227966054 0.30770420705
0.30771206519 0.30771206518 0.30770420703 0.32218118677 0.32218118677 0.32218118677 0.32218118677 0.30594486955 0.30594335561
0.30594335542 0.30594486977 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
...
...
@@ -2350,11 +2350,11 @@ radiation%20flux%20density 1 1056 double
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.0
45828257269
0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.0
23075686633
0.023075686633 0.023075686633 0.023075686633
3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 0.023075686633 0.023075686633 0.023075686633 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.0
54016649708
0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.0
23075686633
0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
...
...
@@ -2376,16 +2376,18 @@ radiation%20flux%20density 1 1056 double
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 3.5449077018e-10 0.023075686633 0.023075686633
0.023075686633 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10
3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.096546969758
0.023075686633 0.023075686633 0.096970616524 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.33595201535 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.047116988585 0.047226570018
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.055973059118 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.090977468929 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.089808631405 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
...
...
@@ -2396,47 +2398,45 @@ radiation%20flux%20density 1 1056 double
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.0593891909 0.059552159567
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.030417405932
0.023075686633 0.030444156141 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 3.5449077018e-10 3.5449077018e-10
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 3.5449077018e-10 3.5449077018e-10
3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.
1989143646
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.
31797356
687 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.
31787704153
0.023075686633 0.023075686633 0.
19870019555
0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.
023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.
065254
687
01
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.
06525468701
0.023075686633 0.023075686633 0.
023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 3.5449077018e-10 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.
13234386366
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.
13220200404
0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.
24794113792
0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.
24801151322
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 0.023075686633 0.0
33730407503 0.03326714704
0.023075686633 0.023075686633
0.
023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.
023075686633
0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.
023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.
023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 0.023075686633 0.0
23075686633 0.023075686633
0.023075686633 0.023075686633
0.023075686633 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 0.023075686633 3.5449077018e-10 3.5449077018e-10 0.023075686633
0.0
66257217748
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.0
6643787687
3 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.
15466582575
0.023075686633 0.023075686633 0.
1545927416
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.0
82729802328 0.080123042093 0.34263041173
0.030
594495786 0.086301194431 0.086251065082 0.032010044893 0.046692345937 0.046753405067 0.3193608757 0.19975845211 0.0320284181
3
0.
19951760204 0.31952621325 0.044485580
78
1
0.
25188461298 0.25216674624 0.044484001075 0.15622780794 0.05422146288 0.15419645667
0.0
54211595019 0.13285539806 0.059351187171 0.059376706305 0.13157605547 0.11865498616 0.088382643945 0.090808734965 0.09081218327
3
0.
36598261776 0.037932399128 0.035571602
33
5
0.02
9760761971 0.32000101634 0.19267386468 0.19265450545 0.029759305289 0.035550386344
0.
32005023901 0.061568072216 0.061551187095 0.13029616202 0.1303006964 0.17047579831 0.17047404096
0.0
6
30
66975951
0.0
6
307
9839045
0.
26565842354 0.26564484716 0.053232020795 0.053229459864 0.082483283923 0.082487261208
0.030
655240205 0.34137400041 0.083887850075
0.0
86488511566 0.046800215772 0.20182260207 0.032070430822 0.32168203171 0.032069000437 0.32173057161 0.046802450842 0.2018078647
3
0.
25110359245 0.044655442419 0.044657430846 0.25108925428 0.15524414841 0.15525006184 0.05454237201 0.054541017199 0.05951958161
0.
13380117143 0.13379189643 0.059516284854
0.0
23075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.0
2307568663
3 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.
023075686633
0.023075686633 0.023075686633 0.
023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.0
23075686633 0.023075686633 0.057622857097
0.0
2
30
75686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.065550103782 0.023075686633 0.02307568663
3
0.
023075686633 0.065550103
78
2
0.
023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.0
23075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.02307568663
3
0.
064669175561 0.023075686633 0.0230756866
33 0.02
3075686633 0.065550103648 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.
065550103648 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.0
2
30
75686633
0.0
2
307
5686633
0.
023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.0
2
30
75686633 0.057712958372 0.023075686633
0.0
23075686633 0.023075686633 0.023075686633 0.023075686633 0.065550103972 0.023075686633 0.065550103972 0.023075686633 0.02307568663
3
0.
023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.
023075686633 0.023075686633 0.023075686633
POINT_DATA 565
FIELD FieldData 1
radiation%20flux%20density 1 565 double
3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 3.5449077018e-10 0.016146817816 0.014992006346 0.010950166202 0.016146817816 0.010950166202
0.016146817816 0.016146817816 0.014992006346 0.01
5455623888
0.016146817816 0.014992006346 0.01
5443330943 0.015046553553
0.016146817816
0.014992006346 0.01
5466686388
0.010950166202 0.0
21579053802 0.29329049938 0.29294309571
0.0
2
16
69959292
0.010950166202 0.01
3347607997
0.016146817816 0.014992006346 0.01
3345138083
0.014992006346 0.016146817816 0.014992006346 0.016146817816 0.016146817816 0.014992006346
0.
2933102466 0.29367229446
0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.011537843494
0.016146817816 0.016146817816 0.014992006346 0.01
0950166202
0.016146817816 0.014992006346 0.01
0950166202 0.010950166202
0.016146817816
0.014992006346 0.01
0950166202
0.010950166202 0.0
16146817816 0.087395597121 0.087395597034
0.016
146817816
0.010950166202 0.01
0950166202
0.016146817816 0.014992006346 0.01
0950166202
0.014992006346 0.016146817816 0.014992006346 0.016146817816 0.016146817816 0.014992006346
0.
087432524054 0.087432524171
0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.011537843494
0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808
0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.011537843494 0.0076918957808
0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808 0.0076918957808
...
...
@@ -2448,34 +2448,34 @@ radiation%20flux%20density 1 565 double
0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202
0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202
0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202
0.035163549499 0.081340181884 0.48984009996 0.48997326348 0.080902476162 0.03640576782 0.010950166202 0.010950166202 0.010950166202
0.010950166202 0.010950166202 0.16559226515 0.16559226514 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202
0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202
0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202
0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202
0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.035515186836 0.080568888889
0.49213308317 0.49204732131 0.080157398104 0.035241215813 0.017260676462 0.017263475384 0.019566519868 0.019565850266 0.033080489741
0.079417894282 0.49420562002 0.49423631182 0.079426728817 0.033074512945 0.48746971264 0.48743891694 0.080990844576 0.035338099137
0.017308936729 0.017309506531 0.036131954968 0.081027401945 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
0.16592262997 0.16592263001 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202 0.010950166202
0.010950166202 0.16570345758 0.1657037099 0.010950166202 0.010950166202 0.1645443406 0.16454408825 0.010950166202 0.010950166202
0.010950166202 0.010950166202 0.010950166202 0.010950166202 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 0.31192061208 0.31191420739
0.30852242486 0.308522425 0.29207948834 0.29207761412 0.29207761401 0.29207948851 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 0.0030344872309 -0.001175354229 0.0042572878828 -0.001175354229 0.021216852903 -0.001175354229 0.00076235437271
-0.001175354229 0.0030312119664 -0.001175354229 0.0043777593774 0.021141170672 -0.001175354229 0.00097010684299 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 0.77837087496 0.77822053198
0.76064919864 0.75987925402 0.69667113695 0.69603947278 0.69656747174 0.69614408001 -0.0015607781637 0.0057519066129 0.0062259930727
-0.001822692051 -0.001175354229 0.0010208692985 0.00062640474318 0.023255720796 -0.0015655945383 0.0044954480163 -0.001175354229 0.0062191246739
-0.001175354229 -0.00041677631927 0.0010451846344 0.024012585483 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229 -0.001175354229
-0.001175354229 0.019779160022 0.023075686633 0.023075686633 0.020191225849 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.01922973892 0.01922973892 0.01922973892 0.01922973892 0.019779160022 0.01922973892
0.023075686633 0.023075686633 0.023075686633 0.019779160022 0.019779160022 0.019779160022 0.019779160022 0.023075686633 0.023075686633
0.023075686633 0.048045658199 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.19066868859 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.027775311274 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.048172760981 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.028427509411
0.023075686633 0.023075686633 0.01922973892 0.01922973892 0.01922973892 0.01922973892 0.01922973892 0.01922973892 0.01922973892
0.01922973892 0.023075686633 0.01922973892 0.01922973892 0.01922973892 0.01922973892 0.01922973892 0.01922973892 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.019779160022 0.019779160022 0.019779160022 0.01922973892 0.01922973892
...
...
@@ -2484,14 +2484,14 @@ radiation%20flux%20density 1 565 double
0.01922973892 0.023075686633 0.019779160022 0.019779160022 0.019779160022 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.10000644619 0.023075686633 0.099950981605 0.023075686633 0.019779160022 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.019779160022 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.076045866122 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.01922973892 0.013845412122 0.013845412122
0.013845412122 0.013845412122 0.023075686633 0.023075686633 0.
21029099605
0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.
210353454
9 0.023075686633 0.023075686633 0.023075686633
0.013845412122 0.013845412122 0.023075686633 0.023075686633 0.
031511486709
0.023075686633 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.023075686633 0.
03151148670
9 0.023075686633 0.023075686633 0.023075686633
0.023075686633 0.018460549378 0.018460549378 0.018460549378 0.023075686633 0.023075686633 0.018460549378 0.018460549378 0.018460549378
0.018460549378 0.018460549378 0.023075686633 0.023075686633 0.018460549378 0.02
7574796675 0.027465669112
0.023075686633 0.023075686633
0.023075686633 0.
18856555428 0.055835711423 0.095283
75
0
68
0.094286544893 0.21196925934 0.047352124
33
2
0.0
47370825119 0.21144478475
0.
10332191051 0.10332222527 0.059820556455 0.22614845232 0.21583145292 0.048639083131 0.21581446586 0.04863483905 0.05628886397
3
0.
18843308607 0.095344190397 0.094914716362 0.047518453226 0.21274159988 0.047516392137 0.2127230391
1
0.018460549378 0.018460549378 0.023075686633 0.023075686633 0.018460549378 0.02
3075686633 0.023075686633
0.023075686633 0.023075686633
0.023075686633 0.
0280109967 0.023075686633 0.0230
7568
6633 0.023075686633 0.031570570063 0.0230756866
33 0.0
23075686633 0.031570570063
0.
023075686633 0.023075686633 0.023075686633 0.030007934788 0.031570570036 0.023075686633 0.031570570036 0.023075686633 0.02307568663
3
0.
02802386831 0.023075686633 0.023075686633 0.023075686633 0.031570570101 0.023075686633 0.03157057010
1
code/tests/input/validation_tests/PN_solver/checkerboard_PN.cfg
View file @
96ad94b5
...
...
@@ -18,7 +18,7 @@ PROBLEM = CHECKERBOARD
% ---- Solver specifications ----
%
CFL_NUMBER = 0.5
TIME_FINAL =
3.2
TIME_FINAL =
0.4
SOLVER = PN_SOLVER
MAX_MOMENT_SOLVER = 2
%
...
...
code/tests/input/validation_tests/PN_solver/checkerboard_PN_reference.vtk
View file @
96ad94b5
...
...
@@ -2311,187 +2311,187 @@ CELL_TYPES 1056
CELL_DATA 1056
FIELD FieldData 1
radiation%20flux%20density 1 1056 double
0.38904523814 -0.49728820662 -0.81917
45
2
751
0.10877022662 1.2083257916 -0.075173904501 -0.026788868919 -0.28362620706 3.4311111097
-
0.29952032556 0.00017502977479 0.082162953095 -2.6270163484 0.5234653321 0.0057496428382 -0.24702935277 0.8049690972 2.6310730426
-
0.41804158682 0.75867472335 -0.22949135501 0.53474264455 -3.5
887777
324 0.11868744547 -1.3432366538 0.18156377352 -0.33764318032
-
0
.6
45734
8657
1 2.0127982757 2.0132214512 -0.73595704861 -3.1816299175 -1.7436149454 2.644739802 1.6466414815 -2.1737299163
1.
6601832229 -1.7576480632 2.7165974765 -2.2113619794 -3.420304092 -2.8270277583 -2.8151747814 -3.38136
79
8
43
-0.4904148507
-
0.50537147341 1.5593351301 1.5701402649 5.2395476777 0.10851871505 5.2569762271 0.11522798402 0.37577515122 -0.4604797333
4